From a80254e9a86c116788669fb03d6c7711cd486594 Mon Sep 17 00:00:00 2001 From: Giorgos Mousa Date: Mon, 3 Jun 2024 12:11:53 +0000 Subject: [PATCH 01/12] Separate ``x, y`` to ``x``, ``y`` --- src/sage/algebras/fusion_rings/f_matrix.py | 9 ++- src/sage/algebras/quantum_groups/q_numbers.py | 2 +- .../algebras/quatalg/quaternion_algebra.py | 4 +- .../algebras/steenrod/steenrod_algebra.py | 6 +- src/sage/arith/functions.pyx | 2 +- src/sage/arith/misc.py | 4 +- src/sage/calculus/functional.py | 5 +- src/sage/categories/coxeter_group_algebras.py | 6 +- src/sage/coding/code_constructions.py | 8 +-- src/sage/coding/delsarte_bounds.py | 4 +- src/sage/coding/grs_code.py | 12 ++-- src/sage/coding/guava.py | 2 +- src/sage/coding/guruswami_sudan/gs_decoder.py | 4 +- src/sage/coding/kasami_codes.pyx | 2 +- src/sage/coding/reed_muller_code.py | 2 +- src/sage/combinat/debruijn_sequence.pyx | 2 +- src/sage/combinat/designs/bibd.py | 12 ++-- src/sage/combinat/designs/block_design.py | 2 +- src/sage/combinat/designs/designs_pyx.pyx | 10 +-- .../combinat/designs/difference_family.py | 8 +-- .../combinat/designs/difference_matrices.py | 16 ++--- .../designs/gen_quadrangles_with_spread.pyx | 4 +- .../designs/group_divisible_designs.py | 2 +- .../combinat/designs/incidence_structures.py | 8 +-- src/sage/combinat/designs/latin_squares.py | 8 +-- .../combinat/designs/orthogonal_arrays.py | 45 +++++++------ .../orthogonal_arrays_build_recursive.py | 32 +++++---- .../orthogonal_arrays_find_recursive.pyx | 28 ++++---- src/sage/combinat/designs/resolvable_bibd.py | 2 +- src/sage/combinat/growth.py | 34 +++++----- src/sage/combinat/integer_vector.py | 2 +- src/sage/combinat/matrices/latin.py | 4 +- src/sage/combinat/ncsf_qsym/combinatorics.py | 22 ++----- src/sage/combinat/partition.py | 8 +-- src/sage/combinat/q_analogues.py | 2 +- .../combinat/root_system/branching_rules.py | 4 +- .../hecke_algebra_representation.py | 2 +- .../root_lattice_realization_algebras.py | 10 +-- src/sage/combinat/rsk.py | 18 ++--- src/sage/combinat/words/paths.py | 2 +- src/sage/crypto/classical.py | 8 +-- src/sage/crypto/lwe.py | 3 +- src/sage/data_structures/blas_dict.pyx | 2 +- .../dynamics/arithmetic_dynamics/wehlerK3.py | 5 +- src/sage/functions/orthogonal_polys.py | 4 +- .../surface3d_generators.py | 2 +- src/sage/graphs/base/c_graph.pyx | 10 +-- src/sage/graphs/base/dense_graph.pyx | 14 ++-- src/sage/graphs/base/graph_backends.pyx | 10 +-- src/sage/graphs/base/sparse_graph.pyx | 22 +++---- .../graphs/base/static_sparse_backend.pyx | 6 +- src/sage/graphs/generators/basic.py | 4 +- .../graphs/generators/classical_geometries.py | 16 ++--- .../graphs/generators/distance_regular.pyx | 20 +++--- src/sage/graphs/generators/families.py | 2 +- src/sage/graphs/generators/intersection.py | 2 +- src/sage/graphs/generators/random.py | 4 +- src/sage/graphs/generic_graph.py | 4 +- src/sage/graphs/hypergraph_generators.py | 2 +- src/sage/graphs/pq_trees.py | 2 +- src/sage/graphs/strongly_regular_db.pyx | 66 +++++++++---------- src/sage/graphs/tutte_polynomial.py | 2 +- src/sage/graphs/views.pyx | 2 +- src/sage/groups/perm_gps/cubegroup.py | 2 +- src/sage/groups/perm_gps/permgroup_named.py | 2 +- src/sage/interfaces/maxima_abstract.py | 2 +- .../matrix/matrix_modn_dense_template.pxi | 4 +- src/sage/matroids/linear_matroid.pyx | 2 +- src/sage/modular/abvar/abvar.py | 2 +- src/sage/modular/abvar/torsion_point.py | 2 +- src/sage/modular/modsym/heilbronn.pyx | 12 ++-- src/sage/modular/modsym/p1list.pyx | 2 +- .../modular/overconvergent/hecke_series.py | 8 +-- .../modular/pollack_stevens/fund_domain.py | 6 +- src/sage/modules/free_module.py | 4 +- src/sage/numerical/mip.pyx | 2 +- src/sage/plot/animate.py | 2 +- src/sage/plot/arc.py | 2 +- src/sage/plot/contour_plot.py | 12 ++-- src/sage/plot/density_plot.py | 4 +- src/sage/plot/ellipse.py | 4 +- src/sage/plot/hyperbolic_arc.py | 4 +- src/sage/plot/hyperbolic_polygon.py | 2 +- src/sage/plot/plot.py | 6 +- .../quadratic_forms/genera/normal_form.py | 2 +- ...otics_multivariate_generating_functions.py | 6 +- src/sage/rings/continued_fraction.py | 2 +- src/sage/rings/continued_fraction_gosper.py | 2 +- .../rings/finite_rings/element_givaro.pyx | 6 +- .../rings/finite_rings/finite_field_givaro.py | 6 +- src/sage/rings/integer_ring.pyx | 2 +- .../laurent_polynomial_ring_base.py | 2 +- .../rings/polynomial/ore_function_field.py | 2 +- .../rings/polynomial/ore_polynomial_ring.py | 2 +- src/sage/rings/polynomial/plural.pyx | 2 +- .../rings/puiseux_series_ring_element.pyx | 6 +- .../elliptic_curves/ell_curve_isogeny.py | 4 +- .../elliptic_curves/ell_finite_field.py | 2 +- .../schemes/elliptic_curves/ell_generic.py | 2 +- src/sage/schemes/elliptic_curves/ell_point.py | 2 +- src/sage/schemes/elliptic_curves/height.py | 4 +- .../schemes/elliptic_curves/hom_velusqrt.py | 3 +- .../schemes/elliptic_curves/period_lattice.py | 4 +- .../elliptic_curves/weierstrass_morphism.py | 8 +-- .../hyperelliptic_curves/monsky_washnitzer.py | 10 +-- src/sage/symbolic/expression.pyx | 4 +- 106 files changed, 369 insertions(+), 371 deletions(-) diff --git a/src/sage/algebras/fusion_rings/f_matrix.py b/src/sage/algebras/fusion_rings/f_matrix.py index 07f4347a1a1..5db72154d0d 100644 --- a/src/sage/algebras/fusion_rings/f_matrix.py +++ b/src/sage/algebras/fusion_rings/f_matrix.py @@ -467,7 +467,8 @@ def fmatrix(self, a, b, c, d): INPUT: - - ``a, b, c, d`` -- basis elements of the associated :class:`FusionRing` + - ``a``, ``b``, ``c``, ``d`` -- basis elements of the associated + :class:`FusionRing` EXAMPLES:: @@ -600,7 +601,8 @@ def f_from(self, a, b, c, d): INPUT: - - ``a, b, c, d`` -- basis elements of the associated :class:`FusionRing` + - ``a``, ``b``, ``c``, ``d`` -- basis elements of the associated + :class:`FusionRing` EXAMPLES:: @@ -624,7 +626,8 @@ def f_to(self, a, b, c, d): INPUT: - - ``a, b, c, d`` -- basis elements of the associated :class:`FusionRing` + - ``a``, ``b``, ``c``, ``d`` -- basis elements of the associated + :class:`FusionRing` EXAMPLES:: diff --git a/src/sage/algebras/quantum_groups/q_numbers.py b/src/sage/algebras/quantum_groups/q_numbers.py index 14ae14b1486..19ee17df5ca 100644 --- a/src/sage/algebras/quantum_groups/q_numbers.py +++ b/src/sage/algebras/quantum_groups/q_numbers.py @@ -146,7 +146,7 @@ def q_binomial(n, k, q=None): INPUT: - - ``n, k`` -- the nonnegative integers `n` and `k` defined above + - ``n``, ``k`` -- the nonnegative integers `n` and `k` defined above - ``q`` -- (default: `q \in \ZZ[q, q^{-1}]`) the parameter `q` (should be invertible) diff --git a/src/sage/algebras/quatalg/quaternion_algebra.py b/src/sage/algebras/quatalg/quaternion_algebra.py index 8bdc1302604..14aba77d5b7 100644 --- a/src/sage/algebras/quatalg/quaternion_algebra.py +++ b/src/sage/algebras/quatalg/quaternion_algebra.py @@ -629,8 +629,8 @@ class QuaternionAlgebra_ab(QuaternionAlgebra_abstract): INPUT: - ``base_ring`` -- a commutative ring `K` in which 2 is invertible - - ``a, b`` -- units of `K` - - ``names`` -- string (default: 'i,j,k') names of the generators + - ``a``, ``b`` -- units of `K` + - ``names`` -- string (default: ``'i,j,k'``) names of the generators OUTPUT: diff --git a/src/sage/algebras/steenrod/steenrod_algebra.py b/src/sage/algebras/steenrod/steenrod_algebra.py index 892ec06a71a..f559e9380bc 100644 --- a/src/sage/algebras/steenrod/steenrod_algebra.py +++ b/src/sage/algebras/steenrod/steenrod_algebra.py @@ -2372,7 +2372,7 @@ def Q_exp(self, *nums): INPUT: - - ``e0, e1, ...`` -- sequence of 0s and 1s + - ``e0``, ``e1``, ... -- sequence of 0s and 1s OUTPUT: The element `Q_0^{e_0} Q_1^{e_1} ...` @@ -2426,7 +2426,7 @@ def Q(self, *nums): INPUT: - - ``n0, n1, ...`` -- non-negative integers + - ``n0``, ``n1``, ... -- non-negative integers OUTPUT: The element `Q_{n0} Q_{n1} ...` @@ -3777,7 +3777,7 @@ def Sq(self, *nums): INPUT: - - ``a, b, c, ...`` -- non-negative integers + - ``a``, ``b``, ``c``, ... -- non-negative integers OUTPUT: element of the Steenrod algebra diff --git a/src/sage/arith/functions.pyx b/src/sage/arith/functions.pyx index a3a9c4ae216..6e8f3db88a5 100644 --- a/src/sage/arith/functions.pyx +++ b/src/sage/arith/functions.pyx @@ -28,7 +28,7 @@ def lcm(a, b=None): INPUT: - - ``a,b`` -- two elements of a ring with lcm or + - ``a``, ``b`` -- two elements of a ring with lcm or - ``a`` -- a list, tuple or iterable of elements of a ring with lcm diff --git a/src/sage/arith/misc.py b/src/sage/arith/misc.py index cc40c569c5d..22ea397d00f 100644 --- a/src/sage/arith/misc.py +++ b/src/sage/arith/misc.py @@ -1740,7 +1740,7 @@ def gcd(a, b=None, **kwargs): INPUT: - - ``a,b`` -- two elements of a ring with gcd or + - ``a``, ``b`` -- two elements of a ring with gcd or - ``a`` -- a list or tuple of elements of a ring with gcd @@ -2419,7 +2419,7 @@ def mqrr_rational_reconstruction(u, m, T): INPUT: - - ``u, m, T`` -- integers such that `m > u \ge 0`, `T > 0`. + - ``u``, ``m``, ``T`` -- integers such that `m > u \ge 0`, `T > 0` OUTPUT: diff --git a/src/sage/calculus/functional.py b/src/sage/calculus/functional.py index fe16e4b80b0..6bd480c20e0 100644 --- a/src/sage/calculus/functional.py +++ b/src/sage/calculus/functional.py @@ -390,9 +390,10 @@ def taylor(f, *args): - ``*args`` -- the following notation is supported - - ``x, a, n`` -- variable, point, degree + - ``x``, ``a``, ``n`` -- variable, point, degree - - ``(x, a), (y, b), ..., n`` -- variables with points, degree of polynomial + - ``(x, a)``, ``(y, b)``, ..., ``n`` -- variables with points, degree of + polynomial EXAMPLES:: diff --git a/src/sage/categories/coxeter_group_algebras.py b/src/sage/categories/coxeter_group_algebras.py index 4ae8427021d..d5e9af95d4e 100644 --- a/src/sage/categories/coxeter_group_algebras.py +++ b/src/sage/categories/coxeter_group_algebras.py @@ -21,7 +21,7 @@ def demazure_lusztig_operator_on_basis(self, w, i, q1, q2, - ``w`` -- an element of the Coxeter group - ``i`` -- an element of the index set - - ``q1,q2`` -- two elements of the ground ring + - ``q1``, ``q2`` -- two elements of the ground ring - ``bar`` -- a boolean (default ``False``) See :meth:`demazure_lusztig_operators` for details. @@ -75,7 +75,7 @@ def demazure_lusztig_operators(self, q1, q2, side="right", affine=True): INPUT: - - ``q1,q2`` -- two elements of the ground ring `K` + - ``q1``, ``q2`` -- two elements of the ground ring `K` - ``side`` -- ``"left"`` or ``"right"`` (default: ``"right"``); which side to act upon - ``affine`` -- a boolean (default: ``True``) @@ -145,7 +145,7 @@ def demazure_lusztig_eigenvectors(self, q1, q2): INPUT: - ``self`` -- a finite Coxeter group `W` - - ``q1,q2`` -- two elements of the ground ring `K` + - ``q1``, ``q2`` -- two elements of the ground ring `K` The affine Hecke algebra `H_{q_1,q_2}(\tilde W)` acts on the group algebra of `W` through the Demazure-Lusztig diff --git a/src/sage/coding/code_constructions.py b/src/sage/coding/code_constructions.py index 211d01a37f9..d1368f6e9a7 100644 --- a/src/sage/coding/code_constructions.py +++ b/src/sage/coding/code_constructions.py @@ -72,12 +72,12 @@ def _is_a_splitting(S1, S2, n, return_automorphism=False): INPUT: - - ``S1, S2`` -- disjoint sublists partitioning ``[1, 2, ..., n-1]`` + - ``S1``, ``S2`` -- disjoint sublists partitioning ``[1, 2, ..., n-1]`` - - ``n`` (integer) + - ``n`` -- integer - - ``return_automorphism`` (boolean) -- whether to return the automorphism - exchanging `S_1` and `S_2`. + - ``return_automorphism`` -- boolean (default: ``False``); whether to + return the automorphism exchanging `S_1` and `S_2` OUTPUT: diff --git a/src/sage/coding/delsarte_bounds.py b/src/sage/coding/delsarte_bounds.py index 44d93d8adb1..7ce70fc347d 100644 --- a/src/sage/coding/delsarte_bounds.py +++ b/src/sage/coding/delsarte_bounds.py @@ -48,7 +48,7 @@ def krawtchouk(n, q, l, x, check=True): INPUT: - - ``n, q, x`` -- arbitrary numbers + - ``n``, ``q``, ``x`` -- arbitrary numbers - ``l`` -- a nonnegative integer @@ -133,7 +133,7 @@ def eberlein(n, w, k, u, check=True): INPUT: - - ``w, k, x`` -- arbitrary numbers + - ``w``, ``k``, ``x`` -- arbitrary numbers - ``n`` -- a nonnegative integer diff --git a/src/sage/coding/grs_code.py b/src/sage/coding/grs_code.py index 682036ef00b..17f5e06114f 100644 --- a/src/sage/coding/grs_code.py +++ b/src/sage/coding/grs_code.py @@ -1548,13 +1548,11 @@ def _partial_xgcd(self, a, b, PolRing): INPUT: - - ``a, b`` -- polynomials over ``PolRing`` + - ``a``, ``b`` -- polynomials over ``PolRing`` - ``PolRing`` -- polynomial ring of the output - OUTPUT: - - - a tuple of polynomials + OUTPUT: tuple of polynomials EXAMPLES:: @@ -2139,13 +2137,11 @@ def _partial_xgcd(self, a, b, PolRing): INPUT: - - ``a, b`` -- polynomials over ``PolRing`` + - ``a``, ``b`` -- polynomials over ``PolRing`` - ``PolRing`` -- polynomial ring of the output - OUTPUT: - - - a tuple of polynomials + OUTPUT: tuple of polynomials EXAMPLES:: diff --git a/src/sage/coding/guava.py b/src/sage/coding/guava.py index 70d808a96fa..4dbe39e85b8 100644 --- a/src/sage/coding/guava.py +++ b/src/sage/coding/guava.py @@ -85,7 +85,7 @@ def RandomLinearCodeGuava(n, k, F): INPUT: - - ``n,k`` -- integers with `n>k>1`. + - ``n``, ``k`` -- integers with `n>k>1`. OUTPUT: diff --git a/src/sage/coding/guruswami_sudan/gs_decoder.py b/src/sage/coding/guruswami_sudan/gs_decoder.py index 25ac03ab6b2..2cd680b5da0 100644 --- a/src/sage/coding/guruswami_sudan/gs_decoder.py +++ b/src/sage/coding/guruswami_sudan/gs_decoder.py @@ -345,8 +345,8 @@ def guruswami_sudan_decoding_radius(C=None, n_k=None, l=None, s=None): - ``tau`` is the obtained decoding radius, and - - ``s, ell`` are the multiplicity parameter, respectively list size - parameter giving this radius. + - ``(s, l)`` are the multiplicity parameter and the list size + parameter giving the radius EXAMPLES:: diff --git a/src/sage/coding/kasami_codes.pyx b/src/sage/coding/kasami_codes.pyx index 5f5b9a02543..383490b4e31 100644 --- a/src/sage/coding/kasami_codes.pyx +++ b/src/sage/coding/kasami_codes.pyx @@ -89,7 +89,7 @@ class KasamiCode(AbstractLinearCode): INPUT: - - ``s,t`` -- (integer) the parameters of the Kasami code + - ``s``, ``t`` -- (integer) the parameters of the Kasami code - ``extended`` -- (default: ``True``) if set to ``True``, creates an extended Kasami code. diff --git a/src/sage/coding/reed_muller_code.py b/src/sage/coding/reed_muller_code.py index 55461a30329..6e35d530c39 100644 --- a/src/sage/coding/reed_muller_code.py +++ b/src/sage/coding/reed_muller_code.py @@ -50,7 +50,7 @@ def _binomial_sum(n, k): INPUT: - - ``n, k`` -- integers + - ``n``, ``k`` -- integers EXAMPLES:: diff --git a/src/sage/combinat/debruijn_sequence.pyx b/src/sage/combinat/debruijn_sequence.pyx index 3a201b34e60..4a3a4ea7ef9 100644 --- a/src/sage/combinat/debruijn_sequence.pyx +++ b/src/sage/combinat/debruijn_sequence.pyx @@ -121,7 +121,7 @@ def is_debruijn_sequence(seq, k, n): - ``seq`` -- Sequence of elements in `0..k-1`. - - ``n,k`` -- Integers. + - ``n``, ``k`` -- Integers. EXAMPLES:: diff --git a/src/sage/combinat/designs/bibd.py b/src/sage/combinat/designs/bibd.py index 34d691795aa..48e24b4ac75 100644 --- a/src/sage/combinat/designs/bibd.py +++ b/src/sage/combinat/designs/bibd.py @@ -125,7 +125,7 @@ def balanced_incomplete_block_design(v, k, lambd=1, existence=False, use_LJCR=Fa INPUT: - - ``v,k,lambd`` (integers) + - ``v``, ``k``, ``lambd`` -- integers - ``existence`` (boolean) -- instead of building the design, return: @@ -371,7 +371,7 @@ def BruckRyserChowla_check(v, k, lambd): INPUT: - - ``v, k, lambd`` -- integers; parameters to check + - ``v``, ``k``, ``lambd`` -- integers; parameters to check OUTPUT: @@ -528,7 +528,7 @@ def BIBD_from_TD(v,k,existence=False): INPUT: - - ``v,k`` -- (integers) computes a `(v,k,1)`-BIBD. + - ``v``, ``k`` -- (integers) computes a `(v,k,1)`-BIBD. - ``existence`` -- (boolean) instead of building the design, return: @@ -852,7 +852,7 @@ def BIBD_from_PBD(PBD, v, k, check=True, base_cases=None): INPUT: - - ``v,k`` -- integers. + - ``v``, ``k`` -- integers. - ``PBD`` -- A PBD on `r=(v-1)/(k-1)` points, such that for any block of ``PBD`` of size `s` there must exist a `((k-1)s+1,k,1)`-BIBD. @@ -1233,7 +1233,7 @@ def PBD_from_TD(k,t,u): INPUT: - - ``k,t,u`` -- integers such that `0\leq u \leq t`. + - ``k``, ``t``, ``u`` -- integers such that `0\leq u \leq t`. EXAMPLES:: @@ -1308,7 +1308,7 @@ def BIBD_from_arc_in_desarguesian_projective_plane(n,k,existence=False): INPUT: - - ``n,k`` (integers) -- must be powers of two (among other restrictions). + - ``n``, ``k`` (integers) -- must be powers of two (among other restrictions). - ``existence`` (boolean) -- whether to return the BIBD obtained through this construction (default), or to merely indicate with a boolean return diff --git a/src/sage/combinat/designs/block_design.py b/src/sage/combinat/designs/block_design.py index af3b7d382ac..96a4fc6e17c 100644 --- a/src/sage/combinat/designs/block_design.py +++ b/src/sage/combinat/designs/block_design.py @@ -107,7 +107,7 @@ def are_hyperplanes_in_projective_geometry_parameters(v, k, lmbda, return_parame INPUT: - - ``v,k,lmbda`` (integers) + - ``v``, ``k``, ``lmbda`` -- integers OUTPUT: diff --git a/src/sage/combinat/designs/designs_pyx.pyx b/src/sage/combinat/designs/designs_pyx.pyx index 4a237ec82b3..054e5782930 100644 --- a/src/sage/combinat/designs/designs_pyx.pyx +++ b/src/sage/combinat/designs/designs_pyx.pyx @@ -222,7 +222,7 @@ def is_orthogonal_array(OA, int k, int n, int t=2, verbose=False, terminology="O - ``OA`` -- the Orthogonal Array to be tested - - ``k,n,t`` (integers) -- only implemented for `t=2`. + - ``k``, ``n``, ``t`` (integers) -- only implemented for `t=2`. - ``verbose`` (boolean) -- whether to display some information when ``OA`` is not an orthogonal array `OA(k,n)`. @@ -755,7 +755,7 @@ def is_quasi_difference_matrix(M,G,int k,int lmbda,int mu,int u,verbose=False): - ``G`` -- a group - - ``k,lmbda,mu,u`` -- integers + - ``k``, ``lmbda``, ``mu``, ``u`` -- integers - ``verbose`` (boolean) -- whether to print some information when the answer is ``False``. @@ -960,7 +960,7 @@ cpdef _OA_cache_set(int k,int n,truth_value): INPUT: - - ``k,n`` (integers) + - ``k``, ``n`` (integers) - ``truth_value`` -- one of ``True,False,Unknown`` """ @@ -995,7 +995,7 @@ cpdef _OA_cache_get(int k,int n): INPUT: - ``k,n`` (integers) + - ``k``, ``n`` -- integers """ if n>=_OA_cache_size: return None @@ -1014,7 +1014,7 @@ cpdef _OA_cache_construction_available(int k,int n): INPUT: - - ``k,n`` (integers) + - ``k``, ``n`` -- integers """ if n>=_OA_cache_size: return Unknown diff --git a/src/sage/combinat/designs/difference_family.py b/src/sage/combinat/designs/difference_family.py index 62fd29e3d50..eb45720a67d 100644 --- a/src/sage/combinat/designs/difference_family.py +++ b/src/sage/combinat/designs/difference_family.py @@ -1123,7 +1123,7 @@ def are_hadamard_difference_set_parameters(v, k, lmbda): INPUT: - - ``(v,k,lmbda)`` -- parameters of a difference set + - ``(v, k, lmbda)`` -- parameters of a difference set EXAMPLES:: @@ -1188,7 +1188,7 @@ def hadamard_difference_set_product(G1, D1, G2, D2): INPUT: - - ``G1,D1``, ``G2,D2`` -- two Hadamard difference sets + - ``G1, D1``, ``G2, D2`` -- two Hadamard difference sets EXAMPLES:: @@ -3463,8 +3463,8 @@ def difference_family(v, k, l=1, existence=False, explain_construction=False, ch INPUT: - - ``v,k,l`` -- parameters of the difference family. If ``l`` is not provided - it is assumed to be ``1`` + - ``v``, ``k``, ``l`` -- parameters of the difference family. If ``l`` is + not provided it is assumed to be ``1`` - ``existence`` -- if ``True``, then return either ``True`` if Sage knows how to build such design, ``Unknown`` if it does not and ``False`` if it knows that the design does not exist diff --git a/src/sage/combinat/designs/difference_matrices.py b/src/sage/combinat/designs/difference_matrices.py index 25986ca2c79..9be65fb4e65 100644 --- a/src/sage/combinat/designs/difference_matrices.py +++ b/src/sage/combinat/designs/difference_matrices.py @@ -26,7 +26,7 @@ def find_product_decomposition(g, k, lmbda=1): INPUT: - - ``g,k,lmbda`` -- integers, parameters of the difference matrix + - ``g``, ``k``, ``lmbda`` -- integers, parameters of the difference matrix OUTPUT: @@ -73,22 +73,22 @@ def find_product_decomposition(g, k, lmbda=1): def difference_matrix_product(k, M1, G1, lmbda1, M2, G2, lmbda2, check=True): r""" - Return the product of the ``(G1,k,lmbda1)`` and ``(G2,k,lmbda2)`` difference - matrices ``M1`` and ``M2``. + Return the product of the ``(G1, k, lmbda1)`` and ``(G2, k, lmbda2)`` + difference matrices ``M1`` and ``M2``. The result is a `(G1 \times G2, k, \lambda_1 \lambda_2)`-difference matrix. INPUT: - - ``k,lmbda1,lmbda2`` -- positive integer + - ``k``, ``lmbda1``, ``lmbda2`` -- positive integers - - ``G1, G2`` -- groups + - ``G1``, ``G2`` -- groups - - ``M1, M2`` -- ``(G1,k,lmbda1)`` and ``(G,k,lmbda2)`` difference + - ``M1``, ``M2`` -- ``(G1, k, lmbda1)`` and ``(G, k, lmbda2)`` difference matrices - - ``check`` (boolean) -- if ``True`` (default), the output is checked before - being returned. + - ``check`` -- boolean (default: ``True``); whether to check the output + before it is returned EXAMPLES:: diff --git a/src/sage/combinat/designs/gen_quadrangles_with_spread.pyx b/src/sage/combinat/designs/gen_quadrangles_with_spread.pyx index 72baf1a5d28..0e21a827210 100644 --- a/src/sage/combinat/designs/gen_quadrangles_with_spread.pyx +++ b/src/sage/combinat/designs/gen_quadrangles_with_spread.pyx @@ -51,7 +51,7 @@ def generalised_quadrangle_with_spread(const int s, const int t, INPUT: - - ``s, t`` -- integers; order of the generalised quadrangle + - ``s``, ``t`` -- integers; order of the generalised quadrangle - ``existence`` -- boolean; @@ -137,7 +137,7 @@ def is_GQ_with_spread(GQ, S, s=None, t=None): - ``S`` -- iterable; the spread of ``GQ`` as an iterable of the blocks of ``GQ`` - - ``s, t`` -- integers (optional); if `(s,t)` are given, then we check that + - ``s``, ``t`` -- integers (optional); if `(s,t)` are given, then we check that ``GQ`` has order `(s,t)` EXAMPLES:: diff --git a/src/sage/combinat/designs/group_divisible_designs.py b/src/sage/combinat/designs/group_divisible_designs.py index aee3bcc96cf..a583dd2607e 100644 --- a/src/sage/combinat/designs/group_divisible_designs.py +++ b/src/sage/combinat/designs/group_divisible_designs.py @@ -59,7 +59,7 @@ def group_divisible_design(v, K, G, existence=False, check=False): - ``v`` (integer) - - ``K,G`` (sets of integers) + - ``K``, ``G`` (sets of integers) - ``existence`` (boolean) -- instead of building the design, return: diff --git a/src/sage/combinat/designs/incidence_structures.py b/src/sage/combinat/designs/incidence_structures.py index 79c95d2c4fb..c6116a7a4f8 100644 --- a/src/sage/combinat/designs/incidence_structures.py +++ b/src/sage/combinat/designs/incidence_structures.py @@ -1486,10 +1486,10 @@ def is_t_design(self, t=None, v=None, k=None, l=None, return_parameters=False): INPUT: - - ``t,v,k,l`` (integers) -- their value is set to ``None`` by - default. The function tests whether the design is a ``t-(v,k,l)`` - design using the provided values and guesses the others. Note that - `l`` cannot be specified if ``t`` is not. + - ``t``, ``v``, ``k``, ``l`` (integers) -- their value is set to + ``None`` by default. The function tests whether the design is a + ``t-(v,k,l)`` design using the provided values and guesses the + others. Note that ``l`` cannot be specified if ``t`` is not. - ``return_parameters`` (boolean)-- whether to return the parameters of the `t`-design. If set to ``True``, the function returns a pair diff --git a/src/sage/combinat/designs/latin_squares.py b/src/sage/combinat/designs/latin_squares.py index d80996db846..e05816e8977 100644 --- a/src/sage/combinat/designs/latin_squares.py +++ b/src/sage/combinat/designs/latin_squares.py @@ -460,10 +460,10 @@ def MOLS_table(start,stop=None,compare=False,width=None): INPUT: - - ``start,stop`` (integers) -- print the table of MOLS for value of `n` such - that ``start<=n= _OA_cache_size: return orthogonal_array(k,n,existence=True) is True diff --git a/src/sage/combinat/designs/resolvable_bibd.py b/src/sage/combinat/designs/resolvable_bibd.py index e79e996dcb5..55afd031183 100644 --- a/src/sage/combinat/designs/resolvable_bibd.py +++ b/src/sage/combinat/designs/resolvable_bibd.py @@ -65,7 +65,7 @@ def resolvable_balanced_incomplete_block_design(v,k,existence=False): INPUT: - - ``v,k`` (integers) + - ``v``, ``k`` (integers) - ``existence`` (boolean) -- instead of building the design, return: diff --git a/src/sage/combinat/growth.py b/src/sage/combinat/growth.py index 3d7e806a0f9..89657cfc2f6 100644 --- a/src/sage/combinat/growth.py +++ b/src/sage/combinat/growth.py @@ -2121,8 +2121,8 @@ def forward_rule(self, y, e, t, f, x, content): INPUT: - - ``y, e, t, f, x`` -- a path of three partitions and two - colors from a cell in a growth diagram, labelled as:: + - ``y``, ``e``, ``t``, ``f``, ``x`` -- a path of three partitions and + two colors from a cell in a growth diagram, labelled as:: t f x e @@ -2221,8 +2221,8 @@ def backward_rule(self, y, g, z, h, x): INPUT: - - ``y, g, z, h, x`` -- a path of three partitions and two - colors from a cell in a growth diagram, labelled as:: + - ``y``, ``g``, ``z``, ``h``, ``x`` -- a path of three partitions and + two colors from a cell in a growth diagram, labelled as:: x h @@ -2514,8 +2514,8 @@ def forward_rule(self, y, e, t, f, x, content): INPUT: - - ``y, e, t, f, x`` -- a path of three partitions and two - colors from a cell in a growth diagram, labelled as:: + - ``y``, ``e``, ``t``, ``f``, ``x`` -- a path of three partitions and + two colors from a cell in a growth diagram, labelled as:: t f x e @@ -2788,7 +2788,7 @@ def forward_rule(self, y, t, x, content): INPUT: - - ``y, t, x`` -- three binary words from a cell in a growth + - ``y``, ``t``, ``x`` -- three binary words from a cell in a growth diagram, labelled as:: t x @@ -2850,7 +2850,7 @@ def backward_rule(self, y, z, x): See [Fom1995]_ Lemma 4.6.1, page 40. - - ``y, z, x`` -- three binary words from a cell in a growth diagram, + - ``y``, ``z``, ``x`` -- three binary words from a cell in a growth diagram, labelled as:: x @@ -3204,7 +3204,7 @@ def forward_rule(self, y, t, x, content): INPUT: - - ``y, t, x`` -- three binary trees from a cell in a growth + - ``y``, ``t``, ``x`` -- three binary trees from a cell in a growth diagram, labelled as:: t x @@ -3327,7 +3327,7 @@ def backward_rule(self, y, z, x): INPUT: - - ``y, z, x`` -- three binary trees from a cell in a growth + - ``y``, ``z``, ``x`` -- three binary trees from a cell in a growth diagram, labelled as:: x @@ -3520,7 +3520,7 @@ def forward_rule(self, y, t, x, content): INPUT: - - ``y, t, x`` -- three Fibonacci words from a + - ``y``, ``t``, ``x`` -- three Fibonacci words from a cell in a growth diagram, labelled as:: t x @@ -3576,7 +3576,7 @@ def backward_rule(self, y, z, x): See [Fom1995]_ Lemma 4.4.1, page 35. - - ``y, z, x`` -- three Fibonacci words from a cell in a + - ``y``, ``z``, ``x`` -- three Fibonacci words from a cell in a growth diagram, labelled as:: x @@ -3764,7 +3764,7 @@ def forward_rule(self, y, t, x, content): INPUT: - - ``y, t, x`` -- three partitions from a cell in a + - ``y``, ``t``, ``x`` -- three partitions from a cell in a growth diagram, labelled as:: t x @@ -3819,7 +3819,7 @@ def backward_rule(self, y, z, x): INPUT: - - ``y, z, x`` -- three partitions from a cell in a + - ``y``, ``z``, ``x`` -- three partitions from a cell in a growth diagram, labelled as:: x @@ -3916,7 +3916,7 @@ def forward_rule(self, y, t, x, content): INPUT: - - ``y, t, x`` -- three from a cell in a growth diagram, + - ``y``, ``t``, ``x`` -- three from a cell in a growth diagram, labelled as:: t x @@ -3965,7 +3965,7 @@ def backward_rule(self, y, z, x): INPUT: - - ``y, z, x`` -- three partitions from a cell in a + - ``y``, ``z``, ``x`` -- three partitions from a cell in a growth diagram, labelled as:: x @@ -4209,7 +4209,7 @@ def forward_rule(self, y, t, x, content): INPUT: - - ``y, t, x`` -- three partitions from a cell in a + - ``y``, ``t``, ``x`` -- three partitions from a cell in a growth diagram, labelled as:: t x diff --git a/src/sage/combinat/integer_vector.py b/src/sage/combinat/integer_vector.py index 1979d00b98c..3f4b59974a4 100644 --- a/src/sage/combinat/integer_vector.py +++ b/src/sage/combinat/integer_vector.py @@ -136,7 +136,7 @@ def gale_ryser_theorem(p1, p2, algorithm="gale", INPUT: - - ``p1, p2`` -- list of integers representing the vectors + - ``p1``, ``p2`` -- list of integers representing the vectors of row/column sums - ``algorithm`` -- two possible string values: diff --git a/src/sage/combinat/matrices/latin.py b/src/sage/combinat/matrices/latin.py index 677073016a9..121a03ee4a2 100644 --- a/src/sage/combinat/matrices/latin.py +++ b/src/sage/combinat/matrices/latin.py @@ -793,8 +793,8 @@ def random_empty_cell(self): OUTPUT: - - ``[r, c]`` -- cell such that self[r, c] is empty, or returns - None if self is a (full) latin square. + - ``[r, c]`` -- cell such that ``self[r, c]`` is empty, or returns + ``None`` if ``self`` is a (full) latin square EXAMPLES:: diff --git a/src/sage/combinat/ncsf_qsym/combinatorics.py b/src/sage/combinat/ncsf_qsym/combinatorics.py index cba0de3d45b..d85efe38719 100644 --- a/src/sage/combinat/ncsf_qsym/combinatorics.py +++ b/src/sage/combinat/ncsf_qsym/combinatorics.py @@ -38,9 +38,7 @@ def coeff_pi(J, I): - ``J`` -- a composition - ``I`` -- a composition refining ``J`` - OUTPUT: - - - integer + OUTPUT: integer EXAMPLES:: @@ -62,9 +60,7 @@ def coeff_lp(J,I): - ``J`` -- a composition - ``I`` -- a composition refining ``J`` - OUTPUT: - - - integer + OUTPUT: integer EXAMPLES:: @@ -86,9 +82,7 @@ def coeff_ell(J,I): - ``J`` -- a composition - ``I`` -- a composition refining ``J`` - OUTPUT: - - - integer + OUTPUT: integer EXAMPLES:: @@ -110,9 +104,7 @@ def coeff_sp(J, I): - ``J`` -- a composition - ``I`` -- a composition refining ``J`` - OUTPUT: - - - integer + OUTPUT: integer EXAMPLES:: @@ -132,11 +124,9 @@ def coeff_dab(I, J): INPUT: - - ``I, J`` -- compositions + - ``I``, ``J`` -- compositions - OUTPUT: - - - An integer + OUTPUT: integer EXAMPLES:: diff --git a/src/sage/combinat/partition.py b/src/sage/combinat/partition.py index 320e1ee764f..f92d533dcb2 100644 --- a/src/sage/combinat/partition.py +++ b/src/sage/combinat/partition.py @@ -3222,7 +3222,7 @@ def arm_length(self, i, j): INPUT: - - ``i, j`` -- two integers + - ``i``, ``j`` -- two integers OUTPUT: @@ -3283,7 +3283,7 @@ def arm_cells(self, i, j): INPUT: - - ``i, j`` -- two integers + - ``i``, ``j`` -- two integers OUTPUT: @@ -3316,7 +3316,7 @@ def leg_length(self, i, j): INPUT: - - ``i, j`` -- two integers + - ``i``, ``j`` -- two integers OUTPUT: @@ -3378,7 +3378,7 @@ def leg_cells(self, i, j): INPUT: - - ``i, j`` -- two integers + - ``i``, ``j`` -- two integers OUTPUT: diff --git a/src/sage/combinat/q_analogues.py b/src/sage/combinat/q_analogues.py index 561372ff2b0..a5e8bb2e1ce 100644 --- a/src/sage/combinat/q_analogues.py +++ b/src/sage/combinat/q_analogues.py @@ -144,7 +144,7 @@ def q_binomial(n, k, q=None, algorithm='auto'): INPUT: - - ``n, k`` -- the values `n` and `k` defined above + - ``n``, ``k`` -- the values `n` and `k` defined above - ``q`` -- (default: ``None``) the variable `q`; if ``None``, then use a default variable in `\ZZ[q]` diff --git a/src/sage/combinat/root_system/branching_rules.py b/src/sage/combinat/root_system/branching_rules.py index b2ace92a56d..4877b972438 100644 --- a/src/sage/combinat/root_system/branching_rules.py +++ b/src/sage/combinat/root_system/branching_rules.py @@ -1016,8 +1016,8 @@ def __init__(self, R, S, f, name="default", intermediate_types=[], """ INPUT: - - ``R, S`` -- CartanTypes - - ``f`` -- a function from the weight lattice of R to the weight lattice of S. + - ``R``, ``S`` -- CartanTypes + - ``f`` -- a function from the weight lattice of R to the weight lattice of S """ self._R = CartanType(R) self._S = CartanType(S) diff --git a/src/sage/combinat/root_system/hecke_algebra_representation.py b/src/sage/combinat/root_system/hecke_algebra_representation.py index e23e9327c07..e9136f2f790 100644 --- a/src/sage/combinat/root_system/hecke_algebra_representation.py +++ b/src/sage/combinat/root_system/hecke_algebra_representation.py @@ -43,7 +43,7 @@ class HeckeAlgebraRepresentation(WithEqualityById, SageObject): - ``domain`` -- a vector space - ``f`` -- a function ``f(l,i)`` taking a basis element `l` of ``domain`` and an index `i`, and returning `F_i` - ``cartan_type`` -- The Cartan type of the Hecke algebra - - ``q1,q2`` -- The eigenvalues of the generators `T` of the Hecke algebra + - ``q1``, ``q2`` -- The eigenvalues of the generators `T` of the Hecke algebra - ``side`` -- "left" or "right" (default: "right") whether this is a left or right representation diff --git a/src/sage/combinat/root_system/root_lattice_realization_algebras.py b/src/sage/combinat/root_system/root_lattice_realization_algebras.py index 30251e983a7..266fb89eb32 100644 --- a/src/sage/combinat/root_system/root_lattice_realization_algebras.py +++ b/src/sage/combinat/root_system/root_lattice_realization_algebras.py @@ -395,7 +395,7 @@ def demazure_lusztig_operators(self, q1, q2, convention="antidominant"): INPUT: - - ``q1,q2`` -- two elements of the ground ring + - ``q1``, ``q2`` -- two elements of the ground ring - ``convention`` -- "antidominant", "bar", or "dominant" (default: "antidominant") If `R` is the parent weight ring, the Demazure-Lusztig @@ -604,7 +604,7 @@ def demazure_lusztig_operator_on_classical_on_basis(self, weight, i, q, q1, q2, - ``weight`` -- a classical weight `\lambda` - ``i`` -- an element of the index set - - ``q1,q2`` -- two elements of the ground ring + - ``q1``, ``q2`` -- two elements of the ground ring - ``convention`` -- ``"antidominant"``, ``"bar"``, or ``"dominant"`` (default: ``"antidominant"``) See :meth:`demazure_lusztig_operators` for the details. @@ -658,7 +658,7 @@ def demazure_lusztig_operators_on_classical(self, q, q1, q2, convention="antidom INPUT: - - ``q,q1,q2`` -- three elements of the ground ring + - ``q``, ``q1``, ``q2`` -- three elements of the ground ring - ``convention`` -- ``"antidominant"``, ``"bar"``, or ``"dominant"`` (default: ``"antidominant"``) Let `KL` be the group algebra of an affine weight lattice @@ -978,7 +978,7 @@ def twisted_demazure_lusztig_operator_on_basis(self, weight, i, q1, q2, conventi - ``weight`` -- an element `\lambda` of the weight lattice - ``i`` -- an element of the index set - - ``q1,q2`` -- two elements of the ground ring + - ``q1``, ``q2`` -- two elements of the ground ring - ``convention`` -- ``"antidominant"``, ``"bar"``, or ``"dominant"`` (default: ``"antidominant"``) .. SEEALSO:: :meth:`twisted_demazure_lusztig_operators` @@ -1023,7 +1023,7 @@ def twisted_demazure_lusztig_operators(self, q1, q2, convention="antidominant"): INPUT: - - ``q1,q2`` -- two elements of the ground ring + - ``q1``, ``q2`` -- two elements of the ground ring - ``convention`` -- ``"antidominant"``, ``"bar"``, or ``"dominant"`` (default: ``"antidominant"``) .. WARNING:: diff --git a/src/sage/combinat/rsk.py b/src/sage/combinat/rsk.py index deb75977056..ca8ea6ca84e 100644 --- a/src/sage/combinat/rsk.py +++ b/src/sage/combinat/rsk.py @@ -220,7 +220,7 @@ def to_pairs(self, obj1=None, obj2=None, check=True): INPUT: - - ``obj1, obj2`` -- anything representing a biword + - ``obj1``, ``obj2`` -- anything representing a biword (see the doc of :meth:`forward_rule` for the encodings accepted). @@ -281,7 +281,7 @@ def forward_rule(self, obj1, obj2, check_standard=False, check=True): INPUT: - - ``obj1, obj2`` -- can be one of the following ways to + - ``obj1``, ``obj2`` -- can be one of the following ways to represent a generalized permutation (or, equivalently, biword): @@ -880,7 +880,7 @@ def forward_rule(self, obj1, obj2, check_standard=False): INPUT: - - ``obj1, obj2`` -- can be one of the following ways to + - ``obj1``, ``obj2`` -- can be one of the following ways to represent a generalized permutation (or, equivalently, biword): @@ -1326,7 +1326,7 @@ def to_pairs(self, obj1=None, obj2=None, check=True): INPUT: - - ``obj1, obj2`` -- anything representing a strict biword + - ``obj1``, ``obj2`` -- anything representing a strict biword (see the doc of :meth:`forward_rule` for the encodings accepted) @@ -1709,7 +1709,7 @@ def to_pairs(self, obj1=None, obj2=None, check=True): INPUT: - - ``obj1, obj2`` -- anything representing a strict + - ``obj1``, ``obj2`` -- anything representing a strict cobiword (see the doc of :meth:`forward_rule` for the encodings accepted) @@ -2029,7 +2029,7 @@ def to_pairs(self, obj1=None, obj2=None, check=True): INPUT: - - ``obj1, obj2`` -- anything representing a restricted super biword + - ``obj1``, ``obj2`` -- anything representing a restricted super biword (see the doc of :meth:`forward_rule` for the encodings accepted) @@ -2159,7 +2159,7 @@ def forward_rule(self, obj1, obj2, check_standard=False, check=True): INPUT: - - ``obj1, obj2`` -- can be one of the following ways to + - ``obj1``, ``obj2`` -- can be one of the following ways to represent a generalized permutation (or, equivalently, biword): @@ -2662,7 +2662,7 @@ def forward_rule(self, obj1, obj2=None, check_braid=True): INPUT: - - ``obj1, obj2`` -- can be one of the following ways to represent a + - ``obj1``, ``obj2`` -- can be one of the following ways to represent a biword (or, equivalently, an increasing 0-Hecke factorization) that is fully commutative: @@ -3048,7 +3048,7 @@ def RSK(obj1=None, obj2=None, insertion=InsertionRules.RSK, check_standard=False INPUT: - - ``obj1, obj2`` -- can be one of the following: + - ``obj1``, ``obj2`` -- can be one of the following: - a word in an ordered alphabet (in this case, ``obj1`` is said word, and ``obj2`` is ``None``) diff --git a/src/sage/combinat/words/paths.py b/src/sage/combinat/words/paths.py index 8faa8f06892..11be7545d8c 100644 --- a/src/sage/combinat/words/paths.py +++ b/src/sage/combinat/words/paths.py @@ -2317,7 +2317,7 @@ def __init__(self, parent, *args, **kwds): - ``parent`` -- a parent object inheriting from Words_all that has the alphabet attribute defined - - ``*args, **kwds`` -- arguments accepted by AbstractWord + - ``*args``, ``**kwds`` -- arguments accepted by AbstractWord EXAMPLES:: diff --git a/src/sage/crypto/classical.py b/src/sage/crypto/classical.py index 546d6cbdd8b..d6740bf396a 100644 --- a/src/sage/crypto/classical.py +++ b/src/sage/crypto/classical.py @@ -293,7 +293,7 @@ def __call__(self, a, b): INPUT: - - ``(a,b)`` -- a secret key; this key is used for both encryption and + - ``(a, b)`` -- a secret key; this key is used for both encryption and decryption. For the affine cryptosystem whose plaintext and ciphertext spaces are `A`, a key is an ordered pair `(a,b) \in \ZZ / n\ZZ \times \ZZ / n\ZZ` where `n` is the size or @@ -982,7 +982,7 @@ def deciphering(self, a, b, C): INPUT: - - ``a, b`` -- a secret key belonging to the key space of this affine + - ``a``, ``b`` -- a secret key belonging to the key space of this affine cipher. This key must be an element of `\ZZ/n\ZZ \times \ZZ/n\ZZ` such that `\gcd(a,n) = 1` with `n` being the size of the ciphertext and plaintext spaces. @@ -1056,7 +1056,7 @@ def enciphering(self, a, b, P): INPUT: - - ``a, b`` -- a secret key belonging to the key space of this affine + - ``a``, ``b`` -- a secret key belonging to the key space of this affine cipher. This key must be an element of `\ZZ/n\ZZ \times \ZZ/n\ZZ` such that `\gcd(a,n) = 1` with `n` being the size of the ciphertext and plaintext spaces. @@ -1181,7 +1181,7 @@ def inverse_key(self, a, b): INPUT: - - ``a, b`` -- a secret key for this affine cipher. The ordered pair + - ``a``, ``b`` -- a secret key for this affine cipher. The ordered pair `(a,b)` must be an element of `\ZZ/n\ZZ \times \ZZ/n\ZZ` such that `\gcd(a,n) = 1`. diff --git a/src/sage/crypto/lwe.py b/src/sage/crypto/lwe.py index 72e78718897..035b05b48a2 100644 --- a/src/sage/crypto/lwe.py +++ b/src/sage/crypto/lwe.py @@ -261,7 +261,8 @@ def __init__(self, n, q, D, secret_dist='uniform', m=None): - "uniform" -- secret follows the uniform distribution in `\Zmod{q}` - "noise" -- secret follows the noise distribution - - ``(lb,ub)`` -- the secret is chosen uniformly from ``[lb,...,ub]`` including both endpoints + - ``(lb, ub)`` -- the secret is chosen uniformly from ``[lb,...,ub]`` + including both endpoints - ``m`` -- number of allowed samples or ``None`` if no such limit exists (default: ``None``) diff --git a/src/sage/data_structures/blas_dict.pyx b/src/sage/data_structures/blas_dict.pyx index 2aec4dceeb5..359ece0690d 100644 --- a/src/sage/data_structures/blas_dict.pyx +++ b/src/sage/data_structures/blas_dict.pyx @@ -42,7 +42,7 @@ cpdef int iaxpy(a, dict X, dict Y, bint remove_zeros=True, bint factor_on_left=T INPUT: - ``a`` -- element of a parent `K` or `±1` - - ``X,Y`` -- dictionaries representing a vector `X` over `K` + - ``X``, ``Y`` -- dictionaries representing a vector `X` over `K` - ``remove_zeros`` -- boolean (default: ``True``); whether to remove the keys whose values are zero after the addition has been performed diff --git a/src/sage/dynamics/arithmetic_dynamics/wehlerK3.py b/src/sage/dynamics/arithmetic_dynamics/wehlerK3.py index b2a36e22a17..eb8134de2b9 100644 --- a/src/sage/dynamics/arithmetic_dynamics/wehlerK3.py +++ b/src/sage/dynamics/arithmetic_dynamics/wehlerK3.py @@ -1723,8 +1723,9 @@ def lambda_minus(self, P, v, N, m, n, prec=100): - ``v`` -- non-negative integer. a place, use v = 0 for the Archimedean place - - ``m,n`` -- positive integers, We compute the local height for the divisor `E_{mn}^{+}`. - These must be indices of non-zero coordinates of the point ``P``. + - ``m``, ``n`` -- positive integers; we compute the local height for + the divisor `E_{mn}^{+}`. These must be indices of non-zero + coordinates of the point ``P``. - ``prec`` -- (default: 100) float point or p-adic precision diff --git a/src/sage/functions/orthogonal_polys.py b/src/sage/functions/orthogonal_polys.py index 1de970e0aa4..ed4d47f793a 100644 --- a/src/sage/functions/orthogonal_polys.py +++ b/src/sage/functions/orthogonal_polys.py @@ -2849,7 +2849,7 @@ class Func_meixner(OrthogonalFunction): - ``n`` -- the degree - ``x`` -- the independent variable `x` - - ``b, c`` -- the parameters `b, c` + - ``b``, ``c`` -- the parameters ``b``, ``c`` """ def __init__(self): """ @@ -2975,7 +2975,7 @@ class Func_hahn(OrthogonalFunction): - ``k`` -- the degree - ``x`` -- the independent variable `x` - - ``a, b`` -- the parameters `a, b` + - ``a``, ``b`` -- the parameters ``a``, ``b`` - ``n`` -- the number of discrete points EXAMPLES: diff --git a/src/sage/geometry/riemannian_manifolds/surface3d_generators.py b/src/sage/geometry/riemannian_manifolds/surface3d_generators.py index 8a1ddc509cd..521cb502f19 100644 --- a/src/sage/geometry/riemannian_manifolds/surface3d_generators.py +++ b/src/sage/geometry/riemannian_manifolds/surface3d_generators.py @@ -110,7 +110,7 @@ def Dini(a=1, b=1, name="Dini's surface"): INPUT: - - ``a, b`` -- surface parameters. + - ``a``, ``b`` -- surface parameters. - ``name`` -- string. Name of the surface. diff --git a/src/sage/graphs/base/c_graph.pyx b/src/sage/graphs/base/c_graph.pyx index 1d1a67ed5b8..770ee23fc68 100644 --- a/src/sage/graphs/base/c_graph.pyx +++ b/src/sage/graphs/base/c_graph.pyx @@ -897,7 +897,7 @@ cdef class CGraph: INPUT: - - ``u, v`` -- non-negative integers, must be in self + - ``u``, ``v`` -- non-negative integers, must be in self OUTPUT: one of @@ -979,7 +979,7 @@ cdef class CGraph: INPUT: - - ``u, v`` -- non-negative integers, must be in self + - ``u``, ``v`` -- non-negative integers, must be in self - ``l`` -- a positive integer label, or zero for no label @@ -1012,7 +1012,7 @@ cdef class CGraph: INPUT: - - ``u, v`` -- non-negative integers, must be in self + - ``u``, ``v`` -- non-negative integers, must be in self - ``l`` -- a positive integer label, or zero for no label @@ -2363,7 +2363,7 @@ cdef class CGraphBackend(GenericGraphBackend): INPUT: - - ``u,v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge - ``l`` -- the edge label @@ -2495,7 +2495,7 @@ cdef class CGraphBackend(GenericGraphBackend): INPUT: - - ``u, v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge - ``l`` -- the edge label diff --git a/src/sage/graphs/base/dense_graph.pyx b/src/sage/graphs/base/dense_graph.pyx index eca8de6afed..098aa305cda 100644 --- a/src/sage/graphs/base/dense_graph.pyx +++ b/src/sage/graphs/base/dense_graph.pyx @@ -290,7 +290,7 @@ cdef class DenseGraph(CGraph): INPUT: - - ``u, v`` -- non-negative integers + - ``u``, ``v`` -- non-negative integers """ if unlikely(l): @@ -306,7 +306,7 @@ cdef class DenseGraph(CGraph): INPUT: - - ``u, v`` -- non-negative integers, must be in self + - ``u``, ``v`` -- non-negative integers, must be in self - ``l`` -- a positive integer label, or zero for no label, or ``-1`` for any label @@ -339,7 +339,7 @@ cdef class DenseGraph(CGraph): INPUT: - - ``u, v`` -- non-negative integers, must be in self + - ``u``, ``v`` -- non-negative integers, must be in self """ self._del_arc_unsafe(u, v) @@ -360,7 +360,7 @@ cdef class DenseGraph(CGraph): INPUT: - - ``u, v`` -- integers from 0, ..., n-1, where n is the number of vertices + - ``u``, ``v`` -- integers from 0, ..., n-1, where n is the number of vertices arc_labels -- must be a pointer to an (allocated) integer array size -- the length of the array @@ -642,7 +642,7 @@ cdef class DenseGraphBackend(CGraphBackend): INPUT: - - ``u, v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge EXAMPLES:: @@ -683,7 +683,7 @@ cdef class DenseGraphBackend(CGraphBackend): INPUT: - - ``u, v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge - ``l`` -- the edge label (ignored) @@ -739,7 +739,7 @@ cdef class DenseGraphBackend(CGraphBackend): INPUT: - - ``u, v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge - ``l`` -- the edge label diff --git a/src/sage/graphs/base/graph_backends.pyx b/src/sage/graphs/base/graph_backends.pyx index 50e05f24e7b..a779c3f4f22 100644 --- a/src/sage/graphs/base/graph_backends.pyx +++ b/src/sage/graphs/base/graph_backends.pyx @@ -84,7 +84,7 @@ cdef class GenericGraphBackend(SageObject): INPUT: - - ``u,v`` -- vertices + - ``u``, ``v`` -- vertices - ``l`` -- edge label - ``directed`` -- boolean @@ -232,7 +232,7 @@ cdef class GenericGraphBackend(SageObject): INPUT: - - ``u,v`` -- vertices + - ``u``, ``v`` -- vertices - ``l`` -- edge label - ``directed`` -- boolean @@ -288,7 +288,7 @@ cdef class GenericGraphBackend(SageObject): INPUT: - - ``u,v`` -- vertex labels + - ``u``, ``v`` -- vertex labels OUTPUT: @@ -310,7 +310,7 @@ cdef class GenericGraphBackend(SageObject): INPUT: - - ``u,v`` -- vertex labels + - ``u``, ``v`` -- vertex labels - ``l`` -- label OUTPUT: @@ -661,7 +661,7 @@ cdef class GenericGraphBackend(SageObject): INPUT: - - ``u,v`` -- vertices + - ``u``, ``v`` -- vertices - ``l`` -- edge label - ``directed`` -- boolean diff --git a/src/sage/graphs/base/sparse_graph.pyx b/src/sage/graphs/base/sparse_graph.pyx index 8672940c404..2a89f481b22 100644 --- a/src/sage/graphs/base/sparse_graph.pyx +++ b/src/sage/graphs/base/sparse_graph.pyx @@ -583,7 +583,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- non-negative integers + - ``u``, ``v`` -- non-negative integers OUTPUT: 0 -- No error. @@ -863,7 +863,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- non-negative integers + - ``u``, ``v`` -- non-negative integers - ``l`` -- a positive integer label, or zero for no label @@ -890,7 +890,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- non-negative integers, must be in self + - ``u``, ``v`` -- non-negative integers, must be in self - ``l`` -- a positive integer label, or zero for no label @@ -924,7 +924,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- integers from `0, ..., n-1`, where `n` is the number of vertices + - ``u``, ``v`` -- integers from `0, ..., n-1`, where `n` is the number of vertices OUTPUT: one of @@ -954,7 +954,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- integers from 0, ..., n-1, where n is the number of vertices + - ``u``, ``v`` -- integers from 0, ..., n-1, where n is the number of vertices arc_labels -- must be a pointer to an (allocated) integer array size -- the length of the array @@ -1001,7 +1001,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- integers from 0, ..., n-1, where n is the number of vertices + - ``u``, ``v`` -- integers from 0, ..., n-1, where n is the number of vertices arc_labels -- must be a pointer to an (allocated) integer array size -- the length of the array @@ -1085,7 +1085,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- integers from `0, ..., n-1`, where `n` is the number of vertices + - ``u``, ``v`` -- integers from `0, ..., n-1`, where `n` is the number of vertices - ``l`` -- a positive integer label, or zero for no label @@ -1117,7 +1117,7 @@ cdef class SparseGraph(CGraph): INPUT: - - ``u, v`` -- integers from `0, ..., n-1`, where `n` is the number of vertices + - ``u``, ``v`` -- integers from `0, ..., n-1`, where `n` is the number of vertices - ``l`` -- a positive integer label, or zero for no label, or ``-1`` for any label @@ -1301,7 +1301,7 @@ cdef class SparseGraphBackend(CGraphBackend): INPUT: - - ``u,v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge EXAMPLES:: @@ -1335,7 +1335,7 @@ cdef class SparseGraphBackend(CGraphBackend): INPUT: - - ``u, v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge - ``l`` -- the edge label, or ``None`` @@ -1401,7 +1401,7 @@ cdef class SparseGraphBackend(CGraphBackend): INPUT: - - ``u,v`` -- the vertices of the edge + - ``u``, ``v`` -- the vertices of the edge - ``l`` -- the edge label diff --git a/src/sage/graphs/base/static_sparse_backend.pyx b/src/sage/graphs/base/static_sparse_backend.pyx index 1dc517a957a..ea65e2117d9 100644 --- a/src/sage/graphs/base/static_sparse_backend.pyx +++ b/src/sage/graphs/base/static_sparse_backend.pyx @@ -240,7 +240,7 @@ cdef class StaticSparseCGraph(CGraph): INPUT: - - ``u,v`` -- integers + - ``u``, ``v`` -- integers TESTS:: @@ -652,7 +652,7 @@ cdef class StaticSparseBackend(CGraphBackend): INPUT: - - ``u,v`` -- two vertices + - ``u``, ``v`` -- two vertices TESTS:: @@ -727,7 +727,7 @@ cdef class StaticSparseBackend(CGraphBackend): INPUT: - - ``u,v`` -- two vertices + - ``u``, ``v`` -- two vertices - ``l`` -- a label diff --git a/src/sage/graphs/generators/basic.py b/src/sage/graphs/generators/basic.py index 216ac0b4e39..3ffdd6dc977 100644 --- a/src/sage/graphs/generators/basic.py +++ b/src/sage/graphs/generators/basic.py @@ -453,7 +453,7 @@ def CompleteBipartiteGraph(p, q, set_position=True): INPUT: - - ``p,q`` -- number of vertices in each side + - ``p``, ``q`` -- number of vertices in each side - ``set_position`` -- boolean (default ``True``); if set to ``True``, we assign positions to the vertices so that the set of cardinality `p` is @@ -828,7 +828,7 @@ def Toroidal6RegularGrid2dGraph(p, q): INPUT: - - ``p, q`` -- integers (see above) + - ``p``, ``q`` -- integers EXAMPLES: diff --git a/src/sage/graphs/generators/classical_geometries.py b/src/sage/graphs/generators/classical_geometries.py index e27f7e11b6d..da04362eef3 100644 --- a/src/sage/graphs/generators/classical_geometries.py +++ b/src/sage/graphs/generators/classical_geometries.py @@ -36,8 +36,8 @@ def SymplecticPolarGraph(d, q, algorithm=None): INPUT: - - ``d,q`` -- integers; note that only even values of `d` are accepted by the - function. + - ``d``, ``q`` -- integers; note that only even values of `d` are accepted + by the function. - ``algorithm`` -- string (default: ``None``); if set to ``'gap'``, then the computation is carried via GAP library interface, computing totally @@ -216,7 +216,7 @@ def _orthogonal_polar_graph(m, q, sign="+", point_type=[0]): INPUT: - - ``m,q`` -- integers; `q` must be a prime power + - ``m``, ``q`` -- integers; `q` must be a prime power - ``sign`` -- string (default: ``"+"``); must be ``"+"`` or ``"-"`` if `m` is even, ``"+"`` (default) otherwise @@ -340,7 +340,7 @@ def OrthogonalPolarGraph(m, q, sign="+"): INPUT: - - ``m,q`` -- integers; `q` must be a prime power + - ``m``, ``q`` -- integers; `q` must be a prime power - ``sign`` -- string (default: ``"+"``); must be ``"+"`` or ``"-"`` if `m` is even, ``"+"`` (default) otherwise @@ -613,7 +613,7 @@ def UnitaryPolarGraph(m, q, algorithm="gap"): INPUT: - - ``m,q`` -- integers; `q` must be a prime power + - ``m``, ``q`` -- integers; `q` must be a prime power - ``algorithm`` -- string (default: ``"gap"``); if set to 'gap' then the computation is carried via GAP library interface, computing totally @@ -686,7 +686,7 @@ def NonisotropicUnitaryPolarGraph(m, q): INPUT: - - ``m,q`` -- integers; `q` must be a prime power + - ``m``, ``q`` -- integers; `q` must be a prime power EXAMPLES:: @@ -749,7 +749,7 @@ def UnitaryDualPolarGraph(m, q): INPUT: - - ``m,q`` -- integers; `q` must be a prime power + - ``m``, ``q`` -- integers; `q` must be a prime power EXAMPLES: @@ -803,7 +803,7 @@ def SymplecticDualPolarGraph(m, q): INPUT: - - ``m,q`` -- integers; `q` must be a prime power, and `m` must be even + - ``m``, ``q`` -- integers; `q` must be a prime power, and `m` must be even EXAMPLES:: diff --git a/src/sage/graphs/generators/distance_regular.pyx b/src/sage/graphs/generators/distance_regular.pyx index e6ef27ef405..532acdd1626 100644 --- a/src/sage/graphs/generators/distance_regular.pyx +++ b/src/sage/graphs/generators/distance_regular.pyx @@ -597,7 +597,7 @@ def UstimenkoGraph(const int m, const int q): INPUT: - - ``m, q`` -- integers; ``q`` must be a prime power and ``m > 1``. + - ``m``, ``q`` -- integers; `q` must be a prime power and `m > 1` EXAMPLES:: @@ -652,7 +652,7 @@ def BilinearFormsGraph(const int d, const int e, const int q): INPUT: - - ``d, e`` -- integers; dimension of the matrices + - ``d``, ``e`` -- integers; dimension of the matrices - ``q`` -- integer; a prime power EXAMPLES:: @@ -1085,7 +1085,7 @@ def GrassmannGraph(const int q, const int n, const int input_e): INPUT: - ``q`` -- a prime power - - ``n, e`` -- integers with ``n > e+1`` + - ``n``, ``e`` -- integers with ``n > e+1`` EXAMPLES:: @@ -1264,7 +1264,7 @@ def graph_from_GQ_spread(const int s, const int t): INPUT: - - ``s, t`` -- integers; order of the generalised quadrangle + - ``s``, ``t`` -- integers; order of the generalised quadrangle EXAMPLES:: @@ -1310,7 +1310,7 @@ def GeneralisedDodecagonGraph(const int s, const int t): INPUT: - - ``s, t`` -- integers; order of the generalised dodecagon + - ``s``, ``t`` -- integers; order of the generalised dodecagon EXAMPLES:: @@ -1418,7 +1418,7 @@ def GeneralisedOctagonGraph(const int s, const int t): INPUT: - - ``s, t`` -- integers; order of the generalised octagon + - ``s``, ``t`` -- integers; order of the generalised octagon EXAMPLES:: @@ -1529,7 +1529,7 @@ def GeneralisedHexagonGraph(const int s, const int t): INPUT: - - ``s, t`` -- integers; order of the generalised hexagon + - ``s``, ``t`` -- integers; order of the generalised hexagon EXAMPLES:: @@ -2099,8 +2099,8 @@ def graph_with_classical_parameters(int d, int b, alpha_in, beta_in, int gamma): INPUT: - - ``d, b, alpha_in, beta_in`` -- numbers; the parameters of the graph; - ``d`` and ``b`` must be integers + - ``d``, ``b``, ``alpha_in``, ``beta_in`` -- numbers; the parameters of the + graph; ``d`` and ``b`` must be integers - ``gamma`` -- element of the enum ``ClassicalParametersGraph`` @@ -2324,7 +2324,7 @@ def pseudo_partition_graph(int m, int a): INPUT: - - ``m, a`` -- integers; parameters of the graph + - ``m``, ``a`` -- integers; parameters of the graph EXAMPLES:: diff --git a/src/sage/graphs/generators/families.py b/src/sage/graphs/generators/families.py index e83ac1f7a33..724d94eedeb 100644 --- a/src/sage/graphs/generators/families.py +++ b/src/sage/graphs/generators/families.py @@ -1336,7 +1336,7 @@ def GoethalsSeidelGraph(k, r): INPUT: - - ``k,r`` -- integers + - ``k``, ``r`` -- integers .. SEEALSO:: diff --git a/src/sage/graphs/generators/intersection.py b/src/sage/graphs/generators/intersection.py index 0434806fb73..7087ca21752 100644 --- a/src/sage/graphs/generators/intersection.py +++ b/src/sage/graphs/generators/intersection.py @@ -408,7 +408,7 @@ def OrthogonalArrayBlockGraph(k, n, OA=None): INPUT: - - ``k,n`` (integers) + - ``k``, ``n`` -- integers - ``OA`` -- An orthogonal array. If set to ``None`` (default) then :func:`~sage.combinat.designs.orthogonal_arrays.orthogonal_array` is diff --git a/src/sage/graphs/generators/random.py b/src/sage/graphs/generators/random.py index a1b73566f2f..64a5da536c1 100644 --- a/src/sage/graphs/generators/random.py +++ b/src/sage/graphs/generators/random.py @@ -193,7 +193,7 @@ def RandomBipartite(n1, n2, p, set_position=False, seed=None): INPUT: - - ``n1, n2`` -- Cardinalities of the two sets + - ``n1``, ``n2`` -- Cardinalities of the two sets - ``p`` -- Probability for an edge to exist @@ -288,7 +288,7 @@ def RandomRegularBipartite(n1, n2, d1, set_position=False, seed=None): INPUT: - - ``n1, n2`` -- number of vertices in each side + - ``n1``, ``n2`` -- number of vertices in each side - ``d1`` -- degree of the vertices in the set of cardinality `n1`. diff --git a/src/sage/graphs/generic_graph.py b/src/sage/graphs/generic_graph.py index 8e30f215317..d3d6a4e8b0c 100644 --- a/src/sage/graphs/generic_graph.py +++ b/src/sage/graphs/generic_graph.py @@ -11041,7 +11041,7 @@ def vertex_disjoint_paths(self, s, t, solver=None, verbose=0, INPUT: - - ``s,t`` -- two vertices of the graph. + - ``s``, ``t`` -- two vertices of the graph. - ``solver`` -- string (default: ``None``); specify a Mixed Integer Linear Programming (MILP) solver to be used. If set to ``None``, the @@ -12895,7 +12895,7 @@ def set_edge_label(self, u, v, l): INPUT: - - ``u, v`` -- the vertices (and direction if digraph) of the edge + - ``u``, ``v`` -- the vertices (and direction if digraph) of the edge - ``l`` -- the new label diff --git a/src/sage/graphs/hypergraph_generators.py b/src/sage/graphs/hypergraph_generators.py index f5218e225f1..642bb3f98e3 100644 --- a/src/sage/graphs/hypergraph_generators.py +++ b/src/sage/graphs/hypergraph_generators.py @@ -211,7 +211,7 @@ def CompleteUniform(self, n, k): INPUT: - - ``k,n`` -- nonnegative integers with `k\leq n` + - ``k``, ``n`` -- nonnegative integers with `k\leq n` EXAMPLES:: diff --git a/src/sage/graphs/pq_trees.py b/src/sage/graphs/pq_trees.py index 1c263635034..016336f7405 100644 --- a/src/sage/graphs/pq_trees.py +++ b/src/sage/graphs/pq_trees.py @@ -428,7 +428,7 @@ def simplify(self, v, left=False, right=False): INPUT: - - ``left, right`` (boolean) -- whether ``v`` is aligned to the + - ``left``, ``right`` -- booleans; whether ``v`` is aligned to the right or to the left - ``v`` -- an element of the ground set diff --git a/src/sage/graphs/strongly_regular_db.pyx b/src/sage/graphs/strongly_regular_db.pyx index fbb47595666..03433266ffc 100644 --- a/src/sage/graphs/strongly_regular_db.pyx +++ b/src/sage/graphs/strongly_regular_db.pyx @@ -57,7 +57,7 @@ def is_paley(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -90,7 +90,7 @@ def is_mathon_PC_srg(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -152,7 +152,7 @@ def is_muzychuk_S6(int v, int k, int l, int mu): INPUT: - - ``v, k, l, mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -202,7 +202,7 @@ def is_orthogonal_array_block_graph(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -262,7 +262,7 @@ def is_johnson(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -302,7 +302,7 @@ def is_steiner(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -347,7 +347,7 @@ def is_affine_polar(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -402,7 +402,7 @@ def is_orthogonal_polar(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -478,7 +478,7 @@ def is_goethals_seidel(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -559,7 +559,7 @@ def is_NOodd(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -630,7 +630,7 @@ def is_NOperp_F5(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -685,7 +685,7 @@ def is_NO_F2(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -736,7 +736,7 @@ def is_NO_F3(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -792,7 +792,7 @@ def is_NU(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -860,7 +860,7 @@ def is_haemers(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -902,7 +902,7 @@ def is_cossidente_penttila(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -947,7 +947,7 @@ def is_complete_multipartite(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1003,7 +1003,7 @@ def is_polhill(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1151,7 +1151,7 @@ def is_RSHCD(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1181,7 +1181,7 @@ def SRG_from_RSHCD(v, k, l, mu, existence=False, check=True): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers - ``existence`` (boolean) -- whether to return a graph or to test if Sage can build such a graph. @@ -1262,7 +1262,7 @@ def is_unitary_polar(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1339,7 +1339,7 @@ def is_unitary_dual_polar(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1390,7 +1390,7 @@ def is_GQqmqp(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1483,7 +1483,7 @@ def is_twograph_descendant_of_srg(int v, int k0, int l, int mu): INPUT: - - ``v,k0,l,mu`` (integers) + - ``v``, ``k0``, ``l``, ``mu`` -- integers OUTPUT: @@ -1543,7 +1543,7 @@ def is_taylor_twograph_srg(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1595,7 +1595,7 @@ def is_switch_skewhad(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1642,7 +1642,7 @@ def is_switch_OA_srg(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1700,7 +1700,7 @@ def is_nowhere0_twoweight(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers OUTPUT: @@ -1745,7 +1745,7 @@ cdef eigenvalues(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers """ # See 1.3.1 of [Distance-regular graphs] @@ -1789,7 +1789,7 @@ def eigenmatrix(int v, int k, int l, int mu): INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers EXAMPLES: @@ -1854,7 +1854,7 @@ cpdef latin_squares_graph_parameters(int v, int k, int l,int mu): INPUT: - - ``v,k,l,mu`` -- (integers) parameters of the graph + - ``v``, ``k``, ``l``, ``mu`` -- - (integrs) parameters of the graph OUTPUT: @@ -2693,7 +2693,7 @@ cdef bint seems_feasible(int v, int k, int l, int mu) noexcept: INPUT: - - ``v,k,l,mu`` (integers) + - ``v``, ``k``, ``l``, ``mu`` -- integers TESTS: @@ -2786,7 +2786,7 @@ def strongly_regular_graph(int v, int k, int l, int mu=-1, bint existence=False, INPUT: - - ``v,k,l,mu`` (integers) -- note that ``mu``, if unspecified, is + - ``v``, ``k``, ``l``, ``mu`` -- integers -- note that ``mu``, if unspecified, is automatically determined from ``v,k,l``. - ``existence`` (boolean;``False``) -- instead of building the graph, diff --git a/src/sage/graphs/tutte_polynomial.py b/src/sage/graphs/tutte_polynomial.py index 6206b963b50..fcd7acd6d3d 100644 --- a/src/sage/graphs/tutte_polynomial.py +++ b/src/sage/graphs/tutte_polynomial.py @@ -605,7 +605,7 @@ def _tutte_polynomial_internal(G, x, y, edge_selector, cache=None): INPUT: - ``G`` -- the graph - - ``x,y`` -- the variables `x,y` respectively + - ``x``, ``y`` -- the variables `x`, `y` respectively - ``edge_selector`` -- the heuristic for selecting edges used in the deletion contraction recurrence diff --git a/src/sage/graphs/views.pyx b/src/sage/graphs/views.pyx index d8eb1b3eae6..95da1be4b64 100644 --- a/src/sage/graphs/views.pyx +++ b/src/sage/graphs/views.pyx @@ -716,7 +716,7 @@ cdef class EdgesView: INPUT: - - ``left,right`` -- :class:`EdgesView` or list of edges + - ``left``, ``right`` -- :class:`EdgesView` or list of edges EXAMPLES:: diff --git a/src/sage/groups/perm_gps/cubegroup.py b/src/sage/groups/perm_gps/cubegroup.py index 20c2267eaeb..1ea023b502d 100644 --- a/src/sage/groups/perm_gps/cubegroup.py +++ b/src/sage/groups/perm_gps/cubegroup.py @@ -1339,7 +1339,7 @@ def cubie(self, size, gap, x, y, z, colors, stickers=True): - ``size`` -- The size of the cubie - ``gap`` -- The gap between cubies - - ``x,y,z`` -- The position of the cubie + - ``x``, ``y``, ``z`` -- The position of the cubie - ``colors`` -- The list of colors - ``stickers`` -- (Default ``True``) Boolean to display stickers diff --git a/src/sage/groups/perm_gps/permgroup_named.py b/src/sage/groups/perm_gps/permgroup_named.py index f84ac5b7cce..c1f2683907b 100644 --- a/src/sage/groups/perm_gps/permgroup_named.py +++ b/src/sage/groups/perm_gps/permgroup_named.py @@ -3130,7 +3130,7 @@ class ComplexReflectionGroup(PermutationGroup_unique): One of the following: - - ``m, p, n`` -- positive integers to construct `G(m,p,n)` + - ``m``, ``p``, ``n`` -- positive integers to construct `G(m,p,n)` - ``m`` -- integer such that `4 \leq m \leq 37` to construct an exceptional complex reflection `G_m` diff --git a/src/sage/interfaces/maxima_abstract.py b/src/sage/interfaces/maxima_abstract.py index efb9821fe23..68c465d71c9 100644 --- a/src/sage/interfaces/maxima_abstract.py +++ b/src/sage/interfaces/maxima_abstract.py @@ -787,7 +787,7 @@ def plot3d_parametric(self, r, vars, urange, vrange, options=None): INPUT: - - ``x, y, z`` -- a string representing a function (such + - ``x``, ``y``, ``z`` -- a string representing a function (such as ``x="u2+v2"``, ...) vars is a list or two strings representing variables (such as vars = ["u","v"]) diff --git a/src/sage/matrix/matrix_modn_dense_template.pxi b/src/sage/matrix/matrix_modn_dense_template.pxi index ce547f2eac6..5a0e84b763c 100644 --- a/src/sage/matrix/matrix_modn_dense_template.pxi +++ b/src/sage/matrix/matrix_modn_dense_template.pxi @@ -2291,8 +2291,8 @@ cdef class Matrix_modn_dense_template(Matrix_dense): INPUT: - - ``row1, row2`` -- the two rows to be transformed (within - self) + - ``row1``, ``row2`` -- the two rows to be transformed (within + ``self``) -``start_col`` -- the column of the pivots in ``row1`` and ``row2``. It is assumed that all entries before ``start_col`` diff --git a/src/sage/matroids/linear_matroid.pyx b/src/sage/matroids/linear_matroid.pyx index 9efceb81b75..688014488be 100644 --- a/src/sage/matroids/linear_matroid.pyx +++ b/src/sage/matroids/linear_matroid.pyx @@ -1782,7 +1782,7 @@ cdef class LinearMatroid(BasisExchangeMatroid): INPUT: - ``F`` -- A flat of codimension 2 - - ``a, b, c, d`` -- elements of the groundset + - ``a``, ``b``, ``c``, ``d`` -- elements of the groundset OUTPUT: diff --git a/src/sage/modular/abvar/abvar.py b/src/sage/modular/abvar/abvar.py index 5b49591308f..2c87874503b 100644 --- a/src/sage/modular/abvar/abvar.py +++ b/src/sage/modular/abvar/abvar.py @@ -749,7 +749,7 @@ def _simple_isogeny(self, other): INPUT: - - ``self, other`` -- modular abelian varieties + - ``self``, ``other`` -- modular abelian varieties OUTPUT: an isogeny diff --git a/src/sage/modular/abvar/torsion_point.py b/src/sage/modular/abvar/torsion_point.py index 6702a231cbb..23e66c2197c 100644 --- a/src/sage/modular/abvar/torsion_point.py +++ b/src/sage/modular/abvar/torsion_point.py @@ -195,7 +195,7 @@ def _richcmp_(self, right, op): INPUT: - - ``self, right`` -- elements of the same finite abelian + - ``self``, ``right`` -- elements of the same finite abelian variety subgroup. - ``op`` -- comparison operator (see :mod:`sage.structure.richcmp`) diff --git a/src/sage/modular/modsym/heilbronn.pyx b/src/sage/modular/modsym/heilbronn.pyx index 821729f54f0..8258c684d1d 100644 --- a/src/sage/modular/modsym/heilbronn.pyx +++ b/src/sage/modular/modsym/heilbronn.pyx @@ -175,7 +175,7 @@ cdef class Heilbronn: INPUT: - - ``u, v, N`` -- integers + - ``u``, ``v``, ``N`` -- integers - ``a, b`` -- preallocated int arrays of the length self. @@ -247,7 +247,7 @@ cdef class Heilbronn: INPUT: - - ``u, v, N`` -- integers + - ``u``, ``v``, ``N`` -- integers OUTPUT: list @@ -525,7 +525,7 @@ def hecke_images_gamma0_weight2(int u, int v, int N, indices, R): """ INPUT: - - ``u, v, N`` -- integers so that gcd(u,v,N) = 1 + - ``u``, ``v``, ``N`` -- integers so that gcd(u,v,N) = 1 - ``indices`` -- a list of positive integers - ``R`` -- matrix over QQ that writes each elements of P1 = P1List(N) in terms of a subset of P1. @@ -650,7 +650,7 @@ def hecke_images_nonquad_character_weight2(int u, int v, int N, indices, chi, R) INPUT: - - ``u, v, N`` -- integers so that gcd(u,v,N) = 1 + - ``u``, ``v``, ``N`` -- integers so that gcd(u,v,N) = 1 - ``indices`` -- a list of positive integers - ``chi`` -- a Dirichlet character that takes values in a nontrivial extension of QQ. @@ -755,7 +755,7 @@ def hecke_images_quad_character_weight2(int u, int v, int N, indices, chi, R): """ INPUT: - - ``u, v, N`` -- integers so that gcd(u,v,N) = 1 + - ``u``, ``v``, ``N`` -- integers so that gcd(u,v,N) = 1 - ``indices`` -- a list of positive integers - ``chi`` -- a Dirichlet character that takes values in QQ - ``R`` -- matrix over QQ(chi) that writes each elements of P1 = @@ -853,7 +853,7 @@ def hecke_images_gamma0_weight_k(int u, int v, int i, int N, int k, indices, R): """ INPUT: - - ``u, v, N`` -- integers so that gcd(u,v,N) = 1 + - ``u``, ``v``, ``N`` -- integers so that gcd(u,v,N) = 1 - ``i`` -- integer with 0 <= i <= k-2 - ``k`` -- weight - ``indices`` -- a list of positive integers diff --git a/src/sage/modular/modsym/p1list.pyx b/src/sage/modular/modsym/p1list.pyx index 9476982af02..188e79e6c01 100644 --- a/src/sage/modular/modsym/p1list.pyx +++ b/src/sage/modular/modsym/p1list.pyx @@ -1087,7 +1087,7 @@ cdef class P1List(): INPUT: - - ``u, v`` -- integers, with `\gcd(u,v,N)=1`, normalized so they lie in the list. + - ``u``, ``v`` -- integers, with `\gcd(u,v,N)=1`, normalized so they lie in the list. OUTPUT: diff --git a/src/sage/modular/overconvergent/hecke_series.py b/src/sage/modular/overconvergent/hecke_series.py index 3f8ebf81ac7..924ebaf5a60 100644 --- a/src/sage/modular/overconvergent/hecke_series.py +++ b/src/sage/modular/overconvergent/hecke_series.py @@ -436,7 +436,7 @@ def complementary_spaces_modp(N, p, k0, n, elldash, LWBModp, bound): - ``N`` -- positive integer at least 2 and not divisible by `p` (level). - ``p`` -- prime at least 5. - ``k0`` -- integer in range 0 to `p-1`. - - ``n, elldash`` -- positive integers. + - ``n``, ``elldash`` -- positive integers. - ``LWBModp`` -- list of lists of `q`-expansions over `GF(p)`. - ``bound`` -- positive even integer (twice the length of the list ``LWBModp``). @@ -489,7 +489,7 @@ def complementary_spaces(N, p, k0, n, mdash, elldashp, elldash, modformsring, bo - ``N`` -- positive integer at least 2 and not divisible by p (level). - ``p`` -- prime at least 5. - ``k0`` -- integer in range 0 to `p - 1`. - - ``n, mdash, elldashp, elldash`` -- positive integers. + - ``n``, ``mdash``, ``elldashp``, ``elldash`` -- positive integers. - ``modformsring`` -- ``True`` or ``False``. - ``bound`` -- positive (even) integer (ignored if ``modformsring`` is True). @@ -555,7 +555,7 @@ def higher_level_katz_exp(p, N, k0, m, mdash, elldash, elldashp, modformsring, b - ``p`` -- prime at least 5. - ``N`` -- positive integer at least 2 and not divisible by `p` (level). - ``k0`` -- integer in range 0 to `p-1`. - - ``m, mdash, elldash, elldashp`` -- positive integers. + - ``m``, ``mdash, ``elldash``, ``elldashp`` -- positive integers. - ``modformsring`` -- ``True`` or ``False``. - ``bound`` -- positive (even) integer. @@ -909,7 +909,7 @@ def katz_expansions(k0, p, ellp, mdash, n): - ``k0`` -- integer in range 0 to `p - 1`. - ``p`` -- prime at least 5. - - ``ellp, mdash, n`` -- positive integers. + - ``ellp``, ``mdash``, ``n`` -- positive integers. OUTPUT: diff --git a/src/sage/modular/pollack_stevens/fund_domain.py b/src/sage/modular/pollack_stevens/fund_domain.py index cab712a95bf..204297362f1 100644 --- a/src/sage/modular/pollack_stevens/fund_domain.py +++ b/src/sage/modular/pollack_stevens/fund_domain.py @@ -1275,7 +1275,7 @@ def is_unimodular_path(self, r1, r2): INPUT: - - ``r1, r2`` -- rational numbers + - ``r1``, ``r2`` -- rational numbers OUTPUT: @@ -1308,8 +1308,8 @@ def unimod_to_matrices(self, r1, r2): INPUT: - - ``r1, r2`` -- rational numbers (that are assumed to be connected by a - unimodular path) + - ``r1``, ``r2`` -- rational numbers (that are assumed to be connected + by a unimodular path) OUTPUT: diff --git a/src/sage/modules/free_module.py b/src/sage/modules/free_module.py index d4606920def..69008abccaf 100644 --- a/src/sage/modules/free_module.py +++ b/src/sage/modules/free_module.py @@ -3280,7 +3280,7 @@ def random_element(self, prob=1.0, *args, **kwds): probability `1-prob`. Otherwise coefficients will be chosen randomly from base ring (and may be zero). - - ``*args, **kwds`` -- passed on to ``random_element()`` function + - ``*args``, ``**kwds`` -- passed on to ``random_element()`` function of base ring. EXAMPLES:: @@ -5949,7 +5949,7 @@ def random_element(self, prob=1.0, *args, **kwds): probability `1-prob`. Otherwise coefficients will be chosen randomly from base ring (and may be zero). - - ``*args, **kwds`` -- passed on to random_element function of base + - ``*args``, ``**kwds`` -- passed on to random_element function of base ring. diff --git a/src/sage/numerical/mip.pyx b/src/sage/numerical/mip.pyx index a6dc57778dc..5bd7448b9c3 100644 --- a/src/sage/numerical/mip.pyx +++ b/src/sage/numerical/mip.pyx @@ -715,7 +715,7 @@ cdef class MixedIntegerLinearProgram(SageObject): INPUT: - - ``binary, integer, real`` -- boolean. Set one of these + - ``binary``, ``integer``, ``real`` -- boolean. Set one of these arguments to ``True`` to ensure that the variable gets the corresponding type. diff --git a/src/sage/plot/animate.py b/src/sage/plot/animate.py index 84eb72157de..cdf1b255eb0 100644 --- a/src/sage/plot/animate.py +++ b/src/sage/plot/animate.py @@ -165,7 +165,7 @@ class Animation(WithEqualityById, SageObject): graphics objects, but if they aren't, then :meth:`make_image` is called on them. - - ``xmin, xmax, ymin, ymax`` -- the ranges of the x and y axes. + - ``xmin``, ``xmax``, ``ymin``, ``ymax`` -- the ranges of the x and y axes. - ``**kwds`` -- all additional inputs are passed onto the rendering command. E.g., use ``figsize`` to adjust the resolution and aspect diff --git a/src/sage/plot/arc.py b/src/sage/plot/arc.py index 33388ef20d4..79dedb5762e 100644 --- a/src/sage/plot/arc.py +++ b/src/sage/plot/arc.py @@ -31,7 +31,7 @@ class Arc(GraphicPrimitive): INPUT: - - ``x,y`` -- coordinates of the center of the arc + - ``x``, ``y`` -- coordinates of the center of the arc - ``r1``, ``r2`` -- lengths of the two radii diff --git a/src/sage/plot/contour_plot.py b/src/sage/plot/contour_plot.py index b6ac3ecd1d2..2d94deaa6ff 100644 --- a/src/sage/plot/contour_plot.py +++ b/src/sage/plot/contour_plot.py @@ -242,10 +242,10 @@ def contour_plot(f, xrange, yrange, **options): - ``f`` -- a function of two variables - - ``(xmin,xmax)`` -- 2-tuple, the range of ``x`` values OR 3-tuple + - ``(xmin, xmax)`` -- 2-tuple, the range of ``x`` values OR 3-tuple ``(x,xmin,xmax)`` - - ``(ymin,ymax)`` -- 2-tuple, the range of ``y`` values OR 3-tuple + - ``(ymin, ymax)`` -- 2-tuple, the range of ``y`` values OR 3-tuple ``(y,ymin,ymax)`` The following inputs must all be passed in as named parameters: @@ -1046,10 +1046,10 @@ def implicit_plot(f, xrange, yrange, **options): - ``f`` -- a function of two variables or equation in two variables - - ``(xmin,xmax)`` -- 2-tuple, the range of ``x`` + - ``(xmin, xmax)`` -- 2-tuple, the range of ``x`` values or ``(x,xmin,xmax)`` - - ``(ymin,ymax)`` -- 2-tuple, the range of ``y`` + - ``(ymin, ymax)`` -- 2-tuple, the range of ``y`` values or ``(y,ymin,ymax)`` The following inputs must all be passed in as named parameters: @@ -1407,10 +1407,10 @@ def region_plot(f, xrange, yrange, **options): - ``f`` -- a boolean function or a list of boolean functions of two variables - - ``(xmin,xmax)`` -- 2-tuple, the range of ``x`` values OR 3-tuple + - ``(xmin, xmax)`` -- 2-tuple, the range of ``x`` values OR 3-tuple ``(x,xmin,xmax)`` - - ``(ymin,ymax)`` -- 2-tuple, the range of ``y`` values OR 3-tuple + - ``(ymin, ymax)`` -- 2-tuple, the range of ``y`` values OR 3-tuple ``(y,ymin,ymax)`` - ``plot_points`` -- integer (default: 100); number of points to plot diff --git a/src/sage/plot/density_plot.py b/src/sage/plot/density_plot.py index 6438cd73fd8..a22394ad2c1 100644 --- a/src/sage/plot/density_plot.py +++ b/src/sage/plot/density_plot.py @@ -163,10 +163,10 @@ def density_plot(f, xrange, yrange, **options): - ``f`` -- a function of two variables - - ``(xmin,xmax)`` -- 2-tuple, the range of ``x`` values OR 3-tuple + - ``(xmin, xmax)`` -- 2-tuple, the range of ``x`` values OR 3-tuple ``(x,xmin,xmax)`` - - ``(ymin,ymax)`` -- 2-tuple, the range of ``y`` values OR 3-tuple + - ``(ymin, ymax)`` -- 2-tuple, the range of ``y`` values OR 3-tuple ``(y,ymin,ymax)`` The following inputs must all be passed in as named parameters: diff --git a/src/sage/plot/ellipse.py b/src/sage/plot/ellipse.py index 564d15cef84..02c598c793f 100644 --- a/src/sage/plot/ellipse.py +++ b/src/sage/plot/ellipse.py @@ -29,9 +29,9 @@ class Ellipse(GraphicPrimitive): INPUT: - - ``x,y`` -- coordinates of the center of the ellipse + - ``x``, ``y`` -- coordinates of the center of the ellipse - - ``r1, r2`` -- radii of the ellipse + - ``r1``, ``r2`` -- radii of the ellipse - ``angle`` -- angle diff --git a/src/sage/plot/hyperbolic_arc.py b/src/sage/plot/hyperbolic_arc.py index 3b08c893d27..82b8bc33586 100644 --- a/src/sage/plot/hyperbolic_arc.py +++ b/src/sage/plot/hyperbolic_arc.py @@ -180,7 +180,7 @@ class HyperbolicArc(HyperbolicArcCore): INPUT: - - ``A, B`` -- end points of the hyperbolic arc + - ``A``, ``B`` -- end points of the hyperbolic arc - ``model`` -- the hyperbolic model used, which is one of the following: * ``'UHP'`` -- upper half plane @@ -238,7 +238,7 @@ def hyperbolic_arc(a, b, model="UHP", **options): INPUT: - - ``a, b`` -- complex numbers connected by a hyperbolic arc + - ``a``, ``b`` -- complex numbers connected by a hyperbolic arc - ``model`` -- (default: ``'UHP'``) hyperbolic model used, which is one of the following: diff --git a/src/sage/plot/hyperbolic_polygon.py b/src/sage/plot/hyperbolic_polygon.py index ba09c3de97c..f13c839d4cc 100644 --- a/src/sage/plot/hyperbolic_polygon.py +++ b/src/sage/plot/hyperbolic_polygon.py @@ -338,7 +338,7 @@ def hyperbolic_triangle(a, b, c, model="UHP", **options): INPUT: - - ``a, b, c`` -- complex numbers in the upper half complex plane + - ``a``, ``b``, ``c`` -- complex numbers in the upper half complex plane OPTIONS: diff --git a/src/sage/plot/plot.py b/src/sage/plot/plot.py index 291b10a6c5b..64643297c5a 100644 --- a/src/sage/plot/plot.py +++ b/src/sage/plot/plot.py @@ -3580,7 +3580,7 @@ def graphics_array(array, nrows=None, ncols=None): :class:`~sage.plot.graphics.Graphics` elements or a single list of :class:`~sage.plot.graphics.Graphics` elements - - ``nrows, ncols`` -- (optional) integers. If both are given then + - ``nrows``, ``ncols`` -- (optional) integers. If both are given then the input array is flattened and turned into an ``nrows`` x ``ncols`` array, with blank graphics objects padded at the end, if necessary. If only one is specified, the other is chosen @@ -3861,7 +3861,7 @@ def adaptive_refinement(f, p1, p2, adaptive_tolerance=0.01, - ``f`` -- a function of one variable - - ``p1, p2`` -- two points to refine between + - ``p1``, ``p2`` -- two points to refine between - ``adaptive_recursion`` -- (default: `5`); how many levels of recursion to go before giving up when doing adaptive @@ -3975,7 +3975,7 @@ def generate_plot_points(f, xrange, plot_points=5, adaptive_tolerance=0.01, - ``f`` -- a function of one variable - - ``p1, p2`` -- two points to refine between + - ``p1``, ``p2`` -- two points to refine between - ``plot_points`` -- (default: `5`); the minimal number of plot points. (Note however that in any actual plot a number is passed to this, with default diff --git a/src/sage/quadratic_forms/genera/normal_form.py b/src/sage/quadratic_forms/genera/normal_form.py index d0bab089708..1dcf13d18e3 100644 --- a/src/sage/quadratic_forms/genera/normal_form.py +++ b/src/sage/quadratic_forms/genera/normal_form.py @@ -1031,7 +1031,7 @@ def _partial_normal_form_of_block(G): OUTPUT: - - ``D, B, w`` -- with ``B`` a transformation matrix such that + - ``D``, ``B``, ``w`` -- with ``B`` a transformation matrix such that ``B * G * B.T`` is in partial normal form and `w = 0, 1, 2` is the size of the part consisting of forms of type W diff --git a/src/sage/rings/asymptotic/asymptotics_multivariate_generating_functions.py b/src/sage/rings/asymptotic/asymptotics_multivariate_generating_functions.py index 5967662ad10..1039ce81bbc 100644 --- a/src/sage/rings/asymptotic/asymptotics_multivariate_generating_functions.py +++ b/src/sage/rings/asymptotic/asymptotics_multivariate_generating_functions.py @@ -3996,7 +3996,7 @@ def diff_op(A, B, AB_derivs, V, M, r, N): - ``V`` -- the variables of the ``A[j]`` and ``B`` - ``M`` -- a symmetric `l \times l` matrix, where `l` is the length of ``V`` - - ``r, N`` -- natural numbers + - ``r``, ``N`` -- natural numbers OUTPUT: @@ -4124,7 +4124,7 @@ def diff_op_simple(A, B, AB_derivs, x, v, a, N): INPUT: - - ``A, B`` -- Symbolic functions in the variable ``x`` + - ``A``, ``B`` -- Symbolic functions in the variable ``x`` - ``AB_derivs`` -- a dictionary whose keys are the (symbolic) derivatives of ``A`` up to order ``2 * N`` if ``v`` is even or ``N`` if ``v`` is odd and the (symbolic) derivatives of ``B`` @@ -4133,7 +4133,7 @@ def diff_op_simple(A, B, AB_derivs, x, v, a, N): that are the keys evaluated at a common point `p` - ``x`` -- a symbolic variable - ``a`` -- a complex number - - ``v, N`` -- natural numbers + - ``v``, ``N`` -- natural numbers OUTPUT: diff --git a/src/sage/rings/continued_fraction.py b/src/sage/rings/continued_fraction.py index d514c5d4048..c51b64261ab 100644 --- a/src/sage/rings/continued_fraction.py +++ b/src/sage/rings/continued_fraction.py @@ -1172,7 +1172,7 @@ def apply_homography(self, a, b, c, d, forward_value=False): INPUT: - - ``a, b, c, d`` -- integers + - ``a``, ``b``, ``c``, ``d`` -- integers - ``forward_value`` -- boolean (default: ``False``) whether the returned continued fraction is given the symbolic value of `(a x + b)/(cx + d)` and not only the diff --git a/src/sage/rings/continued_fraction_gosper.py b/src/sage/rings/continued_fraction_gosper.py index 8074a57793e..bb1a31178e5 100644 --- a/src/sage/rings/continued_fraction_gosper.py +++ b/src/sage/rings/continued_fraction_gosper.py @@ -46,7 +46,7 @@ def __init__(self, a, b, c, d, x): INPUT: - - ``a, b, c, d`` -- integer coefficients of the transformation + - ``a``, ``b``, ``c``, ``d`` -- integer coefficients of the transformation - ``x`` -- a continued fraction diff --git a/src/sage/rings/finite_rings/element_givaro.pyx b/src/sage/rings/finite_rings/element_givaro.pyx index c9b9e323181..17b080eec16 100644 --- a/src/sage/rings/finite_rings/element_givaro.pyx +++ b/src/sage/rings/finite_rings/element_givaro.pyx @@ -686,7 +686,7 @@ cdef class Cache_givaro(Cache_base): INPUT: - - ``a,b,c`` -- :class:`FiniteField_givaroElement` + - ``a``, ``b``, ``c`` -- :class:`FiniteField_givaroElement` EXAMPLES:: @@ -707,7 +707,7 @@ cdef class Cache_givaro(Cache_base): INPUT: - - ``a,b,c`` -- :class:`FiniteField_givaroElement` + - ``a``, ``b``, ``c`` -- :class:`FiniteField_givaroElement` EXAMPLES:: @@ -728,7 +728,7 @@ cdef class Cache_givaro(Cache_base): INPUT: - - ``a,b,c`` -- :class:`FiniteField_givaroElement` + - ``a``, ``b``, ``c`` -- :class:`FiniteField_givaroElement` EXAMPLES:: diff --git a/src/sage/rings/finite_rings/finite_field_givaro.py b/src/sage/rings/finite_rings/finite_field_givaro.py index 9f6abdb40b4..a393535a1fd 100644 --- a/src/sage/rings/finite_rings/finite_field_givaro.py +++ b/src/sage/rings/finite_rings/finite_field_givaro.py @@ -531,7 +531,7 @@ def a_times_b_plus_c(self, a, b, c): INPUT: - - ``a,b,c`` -- :class:`~~sage.rings.finite_rings.element_givaro.FiniteField_givaroElement` + - ``a``, ``b``, ``c`` -- :class:`~~sage.rings.finite_rings.element_givaro.FiniteField_givaroElement` EXAMPLES:: @@ -547,7 +547,7 @@ def a_times_b_minus_c(self, a, b, c): INPUT: - - ``a,b,c`` -- :class:`~sage.rings.finite_rings.element_givaro.FiniteField_givaroElement` + - ``a``, ``b``, ``c`` -- :class:`~sage.rings.finite_rings.element_givaro.FiniteField_givaroElement` EXAMPLES:: @@ -563,7 +563,7 @@ def c_minus_a_times_b(self, a, b, c): INPUT: - - ``a,b,c`` -- :class:`~sage.rings.finite_rings.element_givaro.FiniteField_givaroElement` + - ``a``, ``b``, ``c`` -- :class:`~sage.rings.finite_rings.element_givaro.FiniteField_givaroElement` EXAMPLES:: diff --git a/src/sage/rings/integer_ring.pyx b/src/sage/rings/integer_ring.pyx index d0fb7ac3bc5..f2293d807cf 100644 --- a/src/sage/rings/integer_ring.pyx +++ b/src/sage/rings/integer_ring.pyx @@ -782,7 +782,7 @@ cdef class IntegerRing_class(CommutativeRing): - ``value`` -- this is the variable in which the answer will be returned - - ``x, y, distribution`` -- see :meth:`random_element` + - ``x``, ``y``, ``distribution`` -- see :meth:`random_element` TESTS:: diff --git a/src/sage/rings/polynomial/laurent_polynomial_ring_base.py b/src/sage/rings/polynomial/laurent_polynomial_ring_base.py index 21cc29329e6..44654e1b076 100644 --- a/src/sage/rings/polynomial/laurent_polynomial_ring_base.py +++ b/src/sage/rings/polynomial/laurent_polynomial_ring_base.py @@ -504,7 +504,7 @@ def random_element(self, min_valuation=-2, max_degree=2, *args, **kwds): - ``max_degree`` -- integer (default: ``2``); the maximal allowed degree of the polynomial - - ``*args, **kwds`` -- passed to the random element generator of the + - ``*args``, ``**kwds`` -- passed to the random element generator of the base polynomial ring and base ring itself EXAMPLES:: diff --git a/src/sage/rings/polynomial/ore_function_field.py b/src/sage/rings/polynomial/ore_function_field.py index 502c11c6db2..381668b52d9 100644 --- a/src/sage/rings/polynomial/ore_function_field.py +++ b/src/sage/rings/polynomial/ore_function_field.py @@ -582,7 +582,7 @@ def random_element(self, degree=2, monic=False, *args, **kwds): - ``monic`` -- (default: ``False``) if ``True``, return a monic Ore function with monic numerator and denominator - - ``*args, **kwds`` -- passed in to the ``random_element`` method + - ``*args``, ``**kwds`` -- passed in to the ``random_element`` method for the base ring EXAMPLES:: diff --git a/src/sage/rings/polynomial/ore_polynomial_ring.py b/src/sage/rings/polynomial/ore_polynomial_ring.py index 0667e410565..3a3983a3911 100644 --- a/src/sage/rings/polynomial/ore_polynomial_ring.py +++ b/src/sage/rings/polynomial/ore_polynomial_ring.py @@ -976,7 +976,7 @@ def random_element(self, degree=(-1, 2), monic=False, *args, **kwds): - ``monic`` -- (default: ``False``) if ``True``, return a monic Ore polynomial - - ``*args, **kwds`` -- passed on to the ``random_element`` method + - ``*args``, ``**kwds`` -- passed on to the ``random_element`` method for the base ring OUTPUT: diff --git a/src/sage/rings/polynomial/plural.pyx b/src/sage/rings/polynomial/plural.pyx index 1bbbaedfef3..6a600f74f53 100644 --- a/src/sage/rings/polynomial/plural.pyx +++ b/src/sage/rings/polynomial/plural.pyx @@ -181,7 +181,7 @@ class G_AlgFactory(UniqueFactory): INPUT: - ``base_ring`` -- a ring - - ``c,d`` -- two matrices + - ``c``, ``d`` -- two matrices - ``names`` -- a tuple or list of names - ``order`` -- (optional) term order - ``category`` -- (optional) category diff --git a/src/sage/rings/puiseux_series_ring_element.pyx b/src/sage/rings/puiseux_series_ring_element.pyx index cb69d583e2a..96aa6eaef6e 100644 --- a/src/sage/rings/puiseux_series_ring_element.pyx +++ b/src/sage/rings/puiseux_series_ring_element.pyx @@ -335,8 +335,10 @@ cdef class PuiseuxSeries(AlgebraElement): OUTPUT: - - ``g`` -- int; a ramification index common to self and right - - ``M, N`` -- int, int; scaling factors on self and right, respectively + - ``g`` -- integer; a ramification index common to ``self`` and + ``right`` + - ``M``, ``N`` -- integers; scaling factors on ``self`` and ``right``, + respectively EXAMPLES:: diff --git a/src/sage/schemes/elliptic_curves/ell_curve_isogeny.py b/src/sage/schemes/elliptic_curves/ell_curve_isogeny.py index c3cdd991e58..496731a6c7d 100644 --- a/src/sage/schemes/elliptic_curves/ell_curve_isogeny.py +++ b/src/sage/schemes/elliptic_curves/ell_curve_isogeny.py @@ -2630,8 +2630,8 @@ def __compute_omega_general(self, E, psi, psi_pr, phi, phi_pr): - ``E`` -- an elliptic curve - - ``psi, psi_pr, phi, phi_pr`` -- univariate polynomials over - the base field of ``E``, where ``psi`` is the kernel + - ``psi``, ``psi_pr``, ``phi``, ``phi_pr`` -- univariate polynomials + over the base field of ``E``, where ``psi`` is the kernel polynomial and ``phi`` the numerator of the `X`-coordinate of the isogeny, together with their derivatives diff --git a/src/sage/schemes/elliptic_curves/ell_finite_field.py b/src/sage/schemes/elliptic_curves/ell_finite_field.py index 010373ff769..a6e9cf2e845 100644 --- a/src/sage/schemes/elliptic_curves/ell_finite_field.py +++ b/src/sage/schemes/elliptic_curves/ell_finite_field.py @@ -95,7 +95,7 @@ def plot(self, *args, **kwds): INPUT: - - ``*args, **kwds`` -- all other options are passed + - ``*args``, ``**kwds`` -- all other options are passed to the circle graphing primitive. EXAMPLES:: diff --git a/src/sage/schemes/elliptic_curves/ell_generic.py b/src/sage/schemes/elliptic_curves/ell_generic.py index 957c2fce179..16347cc6a6f 100644 --- a/src/sage/schemes/elliptic_curves/ell_generic.py +++ b/src/sage/schemes/elliptic_curves/ell_generic.py @@ -3271,7 +3271,7 @@ def plot(self, xmin=None, xmax=None, components='both', **args): INPUT: - - ``xmin, xmax`` -- (optional) points will be computed at + - ``xmin``, ``xmax`` -- (optional) points will be computed at least within this range, but possibly farther. - ``components`` -- a string, one of the following: diff --git a/src/sage/schemes/elliptic_curves/ell_point.py b/src/sage/schemes/elliptic_curves/ell_point.py index 936e6e1b180..63d50cc0b0d 100644 --- a/src/sage/schemes/elliptic_curves/ell_point.py +++ b/src/sage/schemes/elliptic_curves/ell_point.py @@ -1488,7 +1488,7 @@ def _line_(self, R, Q): INPUT: - - ``R, Q`` -- points on self.curve() with ``Q`` nonzero. + - ``R``, ``Q`` -- points on self.curve() with ``Q`` nonzero. OUTPUT: diff --git a/src/sage/schemes/elliptic_curves/height.py b/src/sage/schemes/elliptic_curves/height.py index cf6ce234cd3..c382ad1eefe 100644 --- a/src/sage/schemes/elliptic_curves/height.py +++ b/src/sage/schemes/elliptic_curves/height.py @@ -1202,7 +1202,7 @@ def S(self, xi1, xi2, v): INPUT: - - ``xi1, xi2`` (real) -- real numbers with `\xi_1\le\xi_2`. + - ``xi1``, ``xi2`` (real) -- real numbers with `\xi_1\le\xi_2`. - ``v`` (embedding) -- a real embedding of the field. @@ -1250,7 +1250,7 @@ def Sn(self, xi1, xi2, n, v): INPUT: - - ``xi1, xi2`` (real) -- real numbers with `\xi_1\le\xi_2`. + - ``xi1``, ``xi2`` (real) -- real numbers with `\xi_1\le\xi_2`. - ``n`` (integer) -- a positive integer. diff --git a/src/sage/schemes/elliptic_curves/hom_velusqrt.py b/src/sage/schemes/elliptic_curves/hom_velusqrt.py index 769611c61cd..ad6a8919261 100644 --- a/src/sage/schemes/elliptic_curves/hom_velusqrt.py +++ b/src/sage/schemes/elliptic_curves/hom_velusqrt.py @@ -1012,7 +1012,8 @@ def _comparison_impl(left, right, op): INPUT: - - ``left, right`` -- :class:`~sage.schemes.elliptic_curves.hom.EllipticCurveHom` objects + - ``left``, ``right`` -- :class:`~sage.schemes.elliptic_curves.hom.EllipticCurveHom` + objects ALGORITHM: diff --git a/src/sage/schemes/elliptic_curves/period_lattice.py b/src/sage/schemes/elliptic_curves/period_lattice.py index 7cdc5dd6eee..7576bc5c909 100644 --- a/src/sage/schemes/elliptic_curves/period_lattice.py +++ b/src/sage/schemes/elliptic_curves/period_lattice.py @@ -1332,7 +1332,7 @@ def e_log_RC(self, xP, yP, prec=None, reduce=True): INPUT: - - ``xP, yP`` (real or complex) -- Coordinates of a point on + - ``xP``, ``yP`` (real or complex) -- Coordinates of a point on the embedded elliptic curve associated with this period lattice. @@ -1990,7 +1990,7 @@ def normalise_periods(w1, w2): INPUT: - - ``w1,w2`` (complex) -- two complex numbers with non-real ratio + - ``w1``, ``w2`` -- two complex numbers with non-real ratio OUTPUT: diff --git a/src/sage/schemes/elliptic_curves/weierstrass_morphism.py b/src/sage/schemes/elliptic_curves/weierstrass_morphism.py index 30a2e4bd538..4c3313c9a89 100644 --- a/src/sage/schemes/elliptic_curves/weierstrass_morphism.py +++ b/src/sage/schemes/elliptic_curves/weierstrass_morphism.py @@ -44,8 +44,8 @@ class baseWI: INPUT: - - ``u,r,s,t`` (default `(1,0,0,0)`) -- standard parameters of an - isomorphism between Weierstrass models. + - ``u``, ``r``, ``s``, ``t`` -- (default: `1`, `0`, `0`, `0`); standard + parameters of an isomorphism between Weierstrass models EXAMPLES:: @@ -64,8 +64,8 @@ def __init__(self, u=1, r=0, s=0, t=0): INPUT: - - ``u,r,s,t`` (default `(1,0,0,0)`) -- standard parameters of an - isomorphism between Weierstrass models. + - ``u``, ``r``, ``s``, ``t`` -- (default: `1`, `0`, `0`, `0`); standard + parameters of an isomorphism between Weierstrass models EXAMPLES:: diff --git a/src/sage/schemes/hyperelliptic_curves/monsky_washnitzer.py b/src/sage/schemes/hyperelliptic_curves/monsky_washnitzer.py index 793bfe3b27c..8aa49e2e35b 100644 --- a/src/sage/schemes/hyperelliptic_curves/monsky_washnitzer.py +++ b/src/sage/schemes/hyperelliptic_curves/monsky_washnitzer.py @@ -96,7 +96,7 @@ def __init__(self, parent, p0, p1, p2, check=True): - ``parent`` -- a :class:`SpecialCubicQuotientRing` - - ``p0, p1, p2`` -- coefficients; must be coercible + - ``p0``, ``p1``, ``p2`` -- coefficients; must be coercible into parent.poly_ring() - ``check`` -- bool (default: ``True``): whether to carry @@ -604,7 +604,7 @@ def _element_constructor_(self, *args, check=True): INPUT: - - ``p0, p1, p2`` -- coefficients; must be coercible + - ``p0``, ``p1``, ``p2`` -- coefficients; must be coercible into poly_ring() - ``check`` -- bool (default: ``True``): whether to carry @@ -1024,7 +1024,7 @@ def reduce_all(Q, p, coeffs, offset, compute_exact_form=False): OUTPUT: - - ``A, B`` -- pair such that the input differential is + - ``A``, ``B`` -- pair such that the input differential is cohomologous to (A + Bx) dx/y. .. NOTE:: @@ -1110,7 +1110,7 @@ def frobenius_expansion_by_newton(Q, p, M): OUTPUT: - - ``F0, F1`` -- elements of + - ``F0``, ``F1`` -- elements of ``SpecialCubicQuotientRing(Q)``, as described above - ``r`` -- non-negative integer, as described above @@ -1298,7 +1298,7 @@ def frobenius_expansion_by_series(Q, p, M): OUTPUT: - - ``F0, F1`` -- elements of + - ``F0``, ``F1`` -- elements of ``SpecialCubicQuotientRing(Q)``, as described above - ``r`` -- non-negative integer, as described above diff --git a/src/sage/symbolic/expression.pyx b/src/sage/symbolic/expression.pyx index 314325c0a01..a92fe241355 100644 --- a/src/sage/symbolic/expression.pyx +++ b/src/sage/symbolic/expression.pyx @@ -5010,9 +5010,9 @@ cdef class Expression(Expression_abc): - ``*args`` -- the following notation is supported - - ``x, a, n`` -- variable, point, degree + - ``x``, ``a``, ``n`` -- variable, point, degree - - ``(x, a), (y, b), n`` -- variables with points, degree of polynomial + - ``(x, a)``, ``(y, b)``, ``n`` -- variables with points, degree of polynomial EXAMPLES:: From b49e5a79b01a606d3779cef2d6de50f3ead72e4e Mon Sep 17 00:00:00 2001 From: Matthias Koeppe Date: Mon, 3 Jun 2024 10:07:38 -0700 Subject: [PATCH 02/12] src/sage/categories/hecke_modules.py: Fix # needs to fix doctest dataflow warning --- src/sage/categories/hecke_modules.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/sage/categories/hecke_modules.py b/src/sage/categories/hecke_modules.py index f76e233f4a1..14c3f237e0e 100644 --- a/src/sage/categories/hecke_modules.py +++ b/src/sage/categories/hecke_modules.py @@ -143,7 +143,7 @@ def _Hom_(self, Y, category): TESTS:: - sage: H = M._Hom_(M, category=HeckeModules(GF(5))); H # needs sage.modular sage.rings.finite_rings + sage: H = M._Hom_(M, category=HeckeModules(GF(5))); H # needs sage.libs.pari sage.modular Traceback (most recent call last): ... TypeError: Category of Hecke modules over Finite Field of size 5 From 69518172f46889bab5f6f98576e8280904fbd84b Mon Sep 17 00:00:00 2001 From: Volker Braun Date: Tue, 4 Jun 2024 00:12:28 +0200 Subject: [PATCH 03/12] Fix test failure on 32-bit where a different element is picked --- src/sage/geometry/polyhedral_complex.py | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/src/sage/geometry/polyhedral_complex.py b/src/sage/geometry/polyhedral_complex.py index 834789c91c8..56a84be0300 100644 --- a/src/sage/geometry/polyhedral_complex.py +++ b/src/sage/geometry/polyhedral_complex.py @@ -932,8 +932,11 @@ def _an_element_(self): sage: pc = PolyhedralComplex([ ....: Polyhedron(vertices=[(1/3, 1/3), (0, 0), (1, 2)]), ....: Polyhedron(vertices=[(1, 2), (0, 0), (0, 1/2)])]) - sage: pc._an_element_().vertices_list() + sage: element = pc._an_element_().vertices_list() + sage: element # random output (one of the two maximal cells) [[0, 0], [0, 1/2], [1, 2]] + sage: element in ([[0, 0], [0, 1/2], [1, 2]], [[0, 0], [1/3, 1/3], [1, 2]]) + True """ try: return next(self.maximal_cell_iterator(increasing=False)) From e166abf6775879ff849ac185db9f75768db2ac87 Mon Sep 17 00:00:00 2001 From: Giorgos Mousa Date: Tue, 4 Jun 2024 09:15:58 +0000 Subject: [PATCH 04/12] Docstring formatting (outside of `src/sage`) --- build/pkgs/database_symbolic_data/spkg-install.in | 3 --- build/pkgs/jmol/appletweb/JmolHelp.html | 2 -- build/pkgs/sympow/email-exchange.txt | 4 ---- build/sage_bootstrap/cmdline.py | 1 - build/sage_bootstrap/download/cmdline.py | 9 ++++----- build/sage_bootstrap/uncompress/action.py | 1 - m4/ax_boost_base.m4 | 1 - pkgs/sage-sws2rst/sage_sws2rst/worksheet2rst.py | 15 +++++++-------- pkgs/sagemath-objects/MANIFEST.in | 1 - src/bin/sage-fixdoctests | 1 - src/bin/sage-notebook | 1 - src/conftest.py | 1 - src/doc/common/static/custom-jupyter-sphinx.css | 4 ---- .../de/thematische_anleitungen/sage_gymnasium.rst | 1 - src/doc/de/tutorial/interactive_shell.rst | 1 - src/doc/de/tutorial/introduction.rst | 1 - src/doc/de/tutorial/tour_algebra.rst | 1 - src/doc/en/constructions/linear_codes.rst | 1 - src/doc/en/developer/coding_in_other.rst | 1 - src/doc/en/developer/packaging.rst | 2 -- src/doc/en/faq/faq-general.rst | 1 - src/doc/en/reference/plot3d/threejs.rst | 1 - .../coercion_and_categories.rst | 1 - .../nf_introduction.rst | 1 - .../nf_orders.rst | 1 - .../geometry/polyhedra_quicktutorial.rst | 3 --- .../numerical_sage/ctypes_examples.rst | 2 -- .../numerical_sage/parallel_laplace_solver.rst | 4 +--- src/doc/en/thematic_tutorials/sandpile.rst | 1 - .../structures_in_coding_theory.rst | 4 ---- .../tutorial-objects-and-classes.rst | 1 - .../vector_calculus/vector_calc_plane.rst | 2 -- src/doc/en/tutorial/interactive_shell.rst | 1 - src/doc/en/tutorial/tour_algebra.rst | 1 - src/doc/fr/tutorial/interactive_shell.rst | 1 - src/doc/fr/tutorial/tour_algebra.rst | 1 - src/doc/ja/tutorial/afterword.rst | 5 ++--- src/doc/ja/tutorial/interactive_shell.rst | 6 ------ src/doc/ja/tutorial/interfaces.rst | 2 -- src/doc/ja/tutorial/introduction.rst | 7 ------- src/doc/ja/tutorial/latex.rst | 6 ------ src/doc/ja/tutorial/programming.rst | 4 ---- src/doc/ja/tutorial/sagetex.rst | 7 +------ src/doc/ja/tutorial/tour_advanced.rst | 5 ----- src/doc/ja/tutorial/tour_algebra.rst | 13 +++---------- src/doc/ja/tutorial/tour_coercion.rst | 2 -- src/doc/ja/tutorial/tour_functions.rst | 7 +------ src/doc/ja/tutorial/tour_help.rst | 5 +---- src/doc/ja/tutorial/tour_linalg.rst | 2 -- src/doc/ja/tutorial/tour_numtheory.rst | 1 - src/doc/ja/tutorial/tour_plotting.rst | 4 +--- src/doc/ja/tutorial/tour_polynomial.rst | 1 - src/doc/ja/tutorial/tour_rings.rst | 1 - src/doc/pt/tutorial/interactive_shell.rst | 2 -- src/doc/pt/tutorial/tour_algebra.rst | 1 - src/doc/ru/tutorial/interactive_shell.rst | 1 - src/doc/ru/tutorial/interfaces.rst | 1 - src/sage_docbuild/builders.py | 1 - src/sage_docbuild/ext/multidocs.py | 1 - .../flint/templates/flint_sage.pyx.template | 1 - .../autogen/flint/templates/types.pxd.template | 1 - src/sage_setup/autogen/interpreters/generator.py | 1 - .../autogen/interpreters/instructions.py | 1 - src/sage_setup/autogen/interpreters/memory.py | 1 - src/sage_setup/autogen/interpreters/specs/base.py | 1 - src/sage_setup/autogen/interpreters/storage.py | 1 - src/sage_setup/autogen/interpreters/utils.py | 1 - 67 files changed, 21 insertions(+), 150 deletions(-) diff --git a/build/pkgs/database_symbolic_data/spkg-install.in b/build/pkgs/database_symbolic_data/spkg-install.in index d7fb2ccf9f2..44e3380d18b 100644 --- a/build/pkgs/database_symbolic_data/spkg-install.in +++ b/build/pkgs/database_symbolic_data/spkg-install.in @@ -15,6 +15,3 @@ if [ $? -ne 0 ]; then echo >&2 "Error installing symbolic data." exit 1 fi - - - diff --git a/build/pkgs/jmol/appletweb/JmolHelp.html b/build/pkgs/jmol/appletweb/JmolHelp.html index f2eaf3986d1..b6089a5f0db 100644 --- a/build/pkgs/jmol/appletweb/JmolHelp.html +++ b/build/pkgs/jmol/appletweb/JmolHelp.html @@ -2,8 +2,6 @@ - - JmolHelp diff --git a/build/pkgs/sympow/email-exchange.txt b/build/pkgs/sympow/email-exchange.txt index b41f4f8dfb8..44e5022e5aa 100644 --- a/build/pkgs/sympow/email-exchange.txt +++ b/build/pkgs/sympow/email-exchange.txt @@ -17,10 +17,6 @@ work fine on any system that uses 53-bit doubles. On other systems, it will still work for computations less than 16 or so digits (though the current version might die on start-up). - - - - NOTES: 1. getline conflicts with a system-wide function name on diff --git a/build/sage_bootstrap/cmdline.py b/build/sage_bootstrap/cmdline.py index ff11315aa51..cbd4a544bb6 100644 --- a/build/sage_bootstrap/cmdline.py +++ b/build/sage_bootstrap/cmdline.py @@ -40,7 +40,6 @@ Provides scripts to manage the packages of Sage-the-distribution, including SageMath's database of equivalent system packages, and to download and upload tarballs from/to SageMath servers. - """ diff --git a/build/sage_bootstrap/download/cmdline.py b/build/sage_bootstrap/download/cmdline.py index 594cc773b38..12553a0589e 100644 --- a/build/sage_bootstrap/download/cmdline.py +++ b/build/sage_bootstrap/download/cmdline.py @@ -34,7 +34,6 @@ """ - def make_parser(): """ The commandline argument parser for sage-download-file @@ -46,7 +45,7 @@ def make_parser(): help='one of [DEBUG, INFO, ERROR, WARNING, CRITICAL]') parser.add_argument( - '--print-fastest-mirror', action='store_true', + '--print-fastest-mirror', action='store_true', help='Print out the fastest mirror. All other arguments are ignored in that case.') parser.add_argument( @@ -72,7 +71,7 @@ def make_parser(): help="""Where to write the file. If the destination is not specified, a url will be downloaded and the content written to stdout and a tarball will be saved under {SAGE_DISTFILES}""".format(SAGE_DISTFILES=SAGE_DISTFILES)) - + parser.add_argument( '--no-check-certificate', action='store_true', help='Do not check SSL certificates for https connections') @@ -122,7 +121,7 @@ def format_error(message): sys.stderr.write(message) sys.stderr.write(stars) - + def run_safe(): try: run() @@ -132,6 +131,6 @@ def run_safe(): finally: sys.exit(1) - + if __name__ == '__main__': run_safe() diff --git a/build/sage_bootstrap/uncompress/action.py b/build/sage_bootstrap/uncompress/action.py index 8d8af71da5e..0a70a826fb9 100644 --- a/build/sage_bootstrap/uncompress/action.py +++ b/build/sage_bootstrap/uncompress/action.py @@ -22,7 +22,6 @@ ARCHIVE_TYPES = [SageTarFile, SageZipFile, SageTarXZFile] - def open_archive(filename): """ Automatically detect archive type diff --git a/m4/ax_boost_base.m4 b/m4/ax_boost_base.m4 index 16fa69b41f5..2d98c39bbd3 100644 --- a/m4/ax_boost_base.m4 +++ b/m4/ax_boost_base.m4 @@ -187,7 +187,6 @@ AC_DEFUN([_AX_BOOST_BASE_RUNDETECT],[ AC_LANG_POP([C++]) - dnl if we found no boost with system layout we search for boost libraries dnl built and installed without the --layout=system option or for a staged(not installed) version if test "x$succeeded" != "xyes" ; then diff --git a/pkgs/sage-sws2rst/sage_sws2rst/worksheet2rst.py b/pkgs/sage-sws2rst/sage_sws2rst/worksheet2rst.py index 66bfef7f972..8053cf0b5f6 100644 --- a/pkgs/sage-sws2rst/sage_sws2rst/worksheet2rst.py +++ b/pkgs/sage-sws2rst/sage_sws2rst/worksheet2rst.py @@ -3,7 +3,7 @@ r""" Convert worksheet.html files into ReStructuredText documents -This is called by 'sage -sws2rst'. Can also be used as a commandline script +This is called by 'sage -sws2rst'. Can also be used as a commandline script (if BeautifulSoup is installed): ``python worksheet2rst.py worksheet.html`` @@ -17,7 +17,7 @@ - Pablo Angulo Ardoy (2011-02-25): initial version -The content of worksheet.html is split into comments, code, and output +The content of worksheet.html is split into comments, code, and output (the result of evaluating the code), as follows: comments @@ -28,7 +28,6 @@ }}} Each kind of text is dealt with separately. - """ #************************************************** @@ -84,7 +83,7 @@ class States(object): def code_parser(text): """ - + Arguments: INPUT: @@ -95,7 +94,7 @@ def code_parser(text): - string -- rst text - EXAMPLES (not used for unit test, see + EXAMPLES (not used for unit test, see http://groups.google.com/group/sage-devel/browse_thread/thread/d82cb049ac102f3a) : from sage_sws2rst.worksheet2rst import code_parser @@ -140,7 +139,7 @@ def worksheet2rst(s, images_dir=''): - string -- rst text - EXAMPLES (not used for unit test, see + EXAMPLES (not used for unit test, see http://groups.google.com/group/sage-devel/browse_thread/thread/d82cb049ac102f3a) : from sage_sws2rst.worksheet2rst import worksheet2rst @@ -156,7 +155,7 @@ def worksheet2rst(s, images_dir=''): ls = [] for line in s.splitlines(): regex, next_state= transitions[state] - m = regex.match(line) + m = regex.match(line) if m: if state == States.COMMENT: last_cell_id = m.group(1) @@ -192,7 +191,7 @@ def worksheet2rst(s, images_dir=''): return '\n'.join(result) if __name__=='__main__': - if len(sys.argv)>1: + if len(sys.argv)>1: fichero = codecs.open(sys.argv[1], mode='r', encoding='utf-8') text = fichero.read() fichero.close() diff --git a/pkgs/sagemath-objects/MANIFEST.in b/pkgs/sagemath-objects/MANIFEST.in index 98b6910849a..c9b25189372 100644 --- a/pkgs/sagemath-objects/MANIFEST.in +++ b/pkgs/sagemath-objects/MANIFEST.in @@ -74,7 +74,6 @@ include sage/rings/integer_fake.* graft sage/libs/gmp - ## What we do not want: # sage/misc/latex -- this should really go to another package diff --git a/src/bin/sage-fixdoctests b/src/bin/sage-fixdoctests index 0d55581c505..044170fac53 100755 --- a/src/bin/sage-fixdoctests +++ b/src/bin/sage-fixdoctests @@ -1,5 +1,4 @@ #!/usr/bin/env sage-python - """ Given the output of doctest and a file, adjust the doctests so they won't fail. diff --git a/src/bin/sage-notebook b/src/bin/sage-notebook index bd898b2ae54..8cb0d1fa9a6 100755 --- a/src/bin/sage-notebook +++ b/src/bin/sage-notebook @@ -127,7 +127,6 @@ EXAMPLES: * Export a legacy Sage notebook as a Jupyter notebook: sage --notebook=export --ipynb=Output.ipynb admin:10 - """ notebook_launcher = { diff --git a/src/conftest.py b/src/conftest.py index beb82ae6119..6bc7ee2e3fd 100644 --- a/src/conftest.py +++ b/src/conftest.py @@ -1,5 +1,4 @@ # pyright: strict - """Configuration and fixtures for pytest. This file configures pytest and provides some global fixtures. diff --git a/src/doc/common/static/custom-jupyter-sphinx.css b/src/doc/common/static/custom-jupyter-sphinx.css index e79b47b4539..7e090b5e08d 100644 --- a/src/doc/common/static/custom-jupyter-sphinx.css +++ b/src/doc/common/static/custom-jupyter-sphinx.css @@ -134,7 +134,3 @@ body[data-theme="dark"] { } } } - - - - diff --git a/src/doc/de/thematische_anleitungen/sage_gymnasium.rst b/src/doc/de/thematische_anleitungen/sage_gymnasium.rst index 37fbf4322f9..9dc38d8bf0b 100644 --- a/src/doc/de/thematische_anleitungen/sage_gymnasium.rst +++ b/src/doc/de/thematische_anleitungen/sage_gymnasium.rst @@ -1223,7 +1223,6 @@ benutzen wir ``divisors()``:: [1, 2, 3, 4, 6, 12, 13, 26, 39, 52, 78, 156] - Weiterführende Links und Literatur ================================== diff --git a/src/doc/de/tutorial/interactive_shell.rst b/src/doc/de/tutorial/interactive_shell.rst index eae174975af..6e313da4b52 100644 --- a/src/doc/de/tutorial/interactive_shell.rst +++ b/src/doc/de/tutorial/interactive_shell.rst @@ -505,7 +505,6 @@ Hilfe, und ``V.coordinates??`` um den Quelltext der Funktion zu sehen. - Integriertes Hilfesystem ======================== diff --git a/src/doc/de/tutorial/introduction.rst b/src/doc/de/tutorial/introduction.rst index f64ed7ee796..749b774d914 100644 --- a/src/doc/de/tutorial/introduction.rst +++ b/src/doc/de/tutorial/introduction.rst @@ -71,7 +71,6 @@ zur Installation von Sage auf Ihrem Computer zu erhalten. Hier geben wir nur ein paar Kommentare ab. - #. Die herunterladbare Sage-Datei wurde nach der *batteries included* Philosophie zusammengestellt. In anderen Worten, obwohl Sage Python, IPython, PARI, GAP, Singular, Maxima, NTL, GMP und so diff --git a/src/doc/de/tutorial/tour_algebra.rst b/src/doc/de/tutorial/tour_algebra.rst index 59eed8f1888..84e97f773f1 100644 --- a/src/doc/de/tutorial/tour_algebra.rst +++ b/src/doc/de/tutorial/tour_algebra.rst @@ -193,7 +193,6 @@ modelliert, m_2 x_2''+ k_2 (x_2-x_1) = 0, - wobei :math:`m_{i}` die Masse des Objekts *i*, :math:`x_{i}` die Verschiebung des Gleichgewichts der Masse *i* und :math:`k_{i}` die Federkonstante der Feder *i* ist. diff --git a/src/doc/en/constructions/linear_codes.rst b/src/doc/en/constructions/linear_codes.rst index 969713263ad..57b0fe36217 100644 --- a/src/doc/en/constructions/linear_codes.rst +++ b/src/doc/en/constructions/linear_codes.rst @@ -241,7 +241,6 @@ The LFSR sequence is then \end{array} - The sequence of :math:`0,1`'s is periodic with period :math:`P=2^4-1=15` and satisfies Golomb's three randomness conditions. However, this sequence of period 15 can be "cracked" diff --git a/src/doc/en/developer/coding_in_other.rst b/src/doc/en/developer/coding_in_other.rst index 8e046a1eea3..d1abfcb65cb 100644 --- a/src/doc/en/developer/coding_in_other.rst +++ b/src/doc/en/developer/coding_in_other.rst @@ -156,7 +156,6 @@ convert output from PARI to Sage objects: return F, B - .. _section-gap: GAP diff --git a/src/doc/en/developer/packaging.rst b/src/doc/en/developer/packaging.rst index 6a778c3a71a..ae8416cd186 100644 --- a/src/doc/en/developer/packaging.rst +++ b/src/doc/en/developer/packaging.rst @@ -568,7 +568,6 @@ pip for use in a separate process, like ``tox``, then this should be possible. - .. _section-spkg-check: Self-tests @@ -765,7 +764,6 @@ packages add dependencies that happen to be Sage packages, there is a separate source of instability. - .. _section-spkg-SPKG-txt: The SPKG.rst file diff --git a/src/doc/en/faq/faq-general.rst b/src/doc/en/faq/faq-general.rst index f5457ddca0a..7453ca02a0d 100644 --- a/src/doc/en/faq/faq-general.rst +++ b/src/doc/en/faq/faq-general.rst @@ -315,7 +315,6 @@ following commands: $ ./sage --advanced - I want to cite Sage in a publication, how do I do it? """"""""""""""""""""""""""""""""""""""""""""""""""""" diff --git a/src/doc/en/reference/plot3d/threejs.rst b/src/doc/en/reference/plot3d/threejs.rst index 8811a0deb47..411b4157a2f 100644 --- a/src/doc/en/reference/plot3d/threejs.rst +++ b/src/doc/en/reference/plot3d/threejs.rst @@ -144,7 +144,6 @@ An :meth:`~sage.plot.animate.Animation.interactive` animation:: :file: threejs_examples/animation.html - .. RAW:: html