Skip to content

Commit

Permalink
Change some things from British to American spelling (#3367)
Browse files Browse the repository at this point in the history
* `factorisations` -> `factorizations`

* comment and docu fixes

* Add `centraliser` -> `centralizer` deprecation

* `neighbour` -> `neighbor`
  • Loading branch information
lgoettgens authored Feb 16, 2024
1 parent af59f73 commit d373a85
Show file tree
Hide file tree
Showing 19 changed files with 42 additions and 41 deletions.
2 changes: 1 addition & 1 deletion README.md
Original file line number Diff line number Diff line change
Expand Up @@ -54,7 +54,7 @@ julia> zk = maximal_order(k)
Maximal order of Imaginary quadratic field defined by x^2 + 5
with basis AbsSimpleNumFieldElem[1, sqrt(-5)]

julia> factorisations(zk(6))
julia> factorizations(zk(6))
2-element Vector{Fac{AbsSimpleNumFieldOrderElem}}:
-1 * -3 * 2
-1 * (-sqrt(-5) - 1) * (-sqrt(-5) + 1)
Expand Down
2 changes: 1 addition & 1 deletion docs/src/Experimental/Singularities/space_germs.md
Original file line number Diff line number Diff line change
Expand Up @@ -6,7 +6,7 @@ CurrentModule = Oscar

## [Generalities on Space germs](@id space_germ_generalities)

The geometric notion of a space germ is a local concept. A space germ $(X,x)$ at a point $x$ is an equivalence class of ringed spaces, each of which contains $x$ in its underlying topological space, and the equivalence relation is precisely the existence of an open neighbourhood of $x$ on which the spaces coincide.
The geometric notion of a space germ is a local concept. A space germ $(X,x)$ at a point $x$ is an equivalence class of ringed spaces, each of which contains $x$ in its underlying topological space, and the equivalence relation is precisely the existence of an open neighborhood of $x$ on which the spaces coincide.

Depending on the kind of ringed space in question, space germs arise in
different forms:
Expand Down
2 changes: 1 addition & 1 deletion docs/src/NumberTheory/galois.md
Original file line number Diff line number Diff line change
Expand Up @@ -41,7 +41,7 @@ between `K` and `k` can be computed as well.

## Automorphism Group

The automorphisms are computed using various specialised factoring
The automorphisms are computed using various specialized factoring
algorithms: lifting the roots of the defining polynomial in the
given field modulo suitable prime ideal powers and
recovering the true roots from this information.
Expand Down
4 changes: 2 additions & 2 deletions experimental/GModule/Cohomology.jl
Original file line number Diff line number Diff line change
Expand Up @@ -291,7 +291,7 @@ function induce(C::GModule{<:Oscar.GAPGroup, FinGenAbGroup}, h::Map, D = nothing
#= C is Z[U] module, we needd
C otimes Z[G]
any pure tensor c otimes g can be "normalised" g = u*g_i for one of the
any pure tensor c otimes g can be "normalized" g = u*g_i for one of the
reps fixed above, so c otimes g = c otimes u g_i == cu otimes g_i
For the G-action we thus get
Expand Down Expand Up @@ -2080,7 +2080,7 @@ function extension(::Type{PcGroup}, c::CoChain{2,<:Oscar.PcGroupElem})
# F^p = w (order relation)
# compute (F, 0)^p = (?, t) = (?, 0)(1, t)
# compute (w, 0) = (?, s) = (?, 0)(1, s)
# so (?, 0) = (w, 0)(1,s)^-1= (w, 0)(1,-s) if chain is normalised
# so (?, 0) = (w, 0)(1,s)^-1= (w, 0)(1,-s) if chain is normalized
# thus (F, 0)^p = (?, 0)(1, t) = (w, 0)(1,-s)(1, t)
# the ? should be identical, namely the collected version of w
# then (F, 0)^p = (w, t-s) might be the answer
Expand Down
2 changes: 1 addition & 1 deletion experimental/GModule/GModule.jl
Original file line number Diff line number Diff line change
Expand Up @@ -728,7 +728,7 @@ function _two_cocycle(mA::Map, C::GModule{<:Any, <:AbstractAlgebra.FPModule{AbsS
end
I = identity_matrix(K, dim(C))

@vprint :MinField 1 "computing un-normalised 1-chain (of matrices)\n"
@vprint :MinField 1 "computing un-normalized 1-chain (of matrices)\n"
# pairs: (g, X_g) with operation (g, X_g)(h, X_h) = (gh, X_g^h * X_h)
@vtime :MinField 2
c = closure([(gen(G, i), homs[i]) for i=1:ngens(G)],
Expand Down
2 changes: 1 addition & 1 deletion experimental/GModule/GaloisCohomology.jl
Original file line number Diff line number Diff line change
Expand Up @@ -1292,7 +1292,7 @@ end
For `K/k` a number field, where `k` has to be Antic or QQField and `K` Antic
return a container for the relative Brauer group parametrizing central
simple algebras with center `k` that are split by `K` (thus can be realised
simple algebras with center `k` that are split by `K` (thus can be realized
as a 2-cochain with values in `K`)
"""
mutable struct RelativeBrauerGroup
Expand Down
2 changes: 1 addition & 1 deletion experimental/QuadFormAndIsom/src/embeddings.jl
Original file line number Diff line number Diff line change
Expand Up @@ -1710,7 +1710,7 @@ function admissible_equivariant_primitive_extensions(A::ZZLatWithIsom,

# We look for the GA|GB-invariant and fA|fB-stable subgroups of VA|VB which respectively
# contained lpqA|lpqB, where pqA and pqB are respectively the p-primary parts of qA and qB.
# This is done by computing orbits and stabilisers of VA/lpqA (resp VB/lpqB)
# This is done by computing orbits and stabilizers of VA/lpqA (resp VB/lpqB)
# seen as a F_p-vector space under the action of GA (resp. GB). Then we check which ones
# are fA-stable (resp. fB-stable)
subsA = _subgroups_orbit_representatives_and_stabilizers_elementary(VAinqA, GA, p^g, fqA, ZZ(l))
Expand Down
2 changes: 1 addition & 1 deletion experimental/Schemes/SpaceGerms.jl
Original file line number Diff line number Diff line change
Expand Up @@ -592,7 +592,7 @@ end
CompleteIntersectionGerm(X::AbsSpec, p::AbsAffineRationalPoint)
CompleteIntersectionGerm(p::AbsAffineRationalPoint)
Return a complete intersection germ `(X,p)` for a given `X`and a rational point `p` on some affine scheme `Y`, provided that $X$ is locally a complete intersection in some neighbourhood of `p`. If no `X` is specified, `Y` is used in its place.
Return a complete intersection germ `(X,p)` for a given `X`and a rational point `p` on some affine scheme `Y`, provided that $X$ is locally a complete intersection in some neighborhood of `p`. If no `X` is specified, `Y` is used in its place.
"""
CompleteIntersectionGerm(p::AbsAffineRationalPoint) = CompleteIntersectionGerm(codomain(p), coordinates(p))

Expand Down
2 changes: 0 additions & 2 deletions src/Groups/sub.jl
Original file line number Diff line number Diff line change
Expand Up @@ -354,8 +354,6 @@ function centralizer(G::GAPGroup, x::GAPGroupElem)
return _as_subgroup(G, GAP.Globals.Centralizer(G.X, x.X))
end

const centraliser = centralizer # FIXME/TODO: use @alias?

################################################################################
#
#
Expand Down
2 changes: 1 addition & 1 deletion src/NumberTheory/GaloisGrp/GaloisGrp.jl
Original file line number Diff line number Diff line change
Expand Up @@ -1669,7 +1669,7 @@ function starting_group(GC::GaloisCtx, K::T; useSubfields::Bool = true) where T
O = sum_orbits(K, x->mk(pc(map_coeff(GC, x))), map(mk, c))
GC.start = (2, O)

#the factors define a partitioning of pairs, the stabiliser of this
#the factors define a partitioning of pairs, the stabilizer of this
#partition is the largest possible group...
#code from Max...

Expand Down
2 changes: 1 addition & 1 deletion src/NumberTheory/GaloisGrp/Qt.jl
Original file line number Diff line number Diff line change
Expand Up @@ -710,7 +710,7 @@ function Hecke.newton_polygon(f::T) where T <: Generic.Poly{S} where S <: Union{
dev = collect(coefficients(f))
d = degree(base_ring(f))
a = Tuple{Int, Int}[]
#careful: valuation is q-valued, normalised for val(p) == 1
#careful: valuation is q-valued, normalized for val(p) == 1
# lines have Int corredinated, so we scale by the degree of the field
# => the slopes are also multiplied by this!!!
for i = 0:length(dev) -1
Expand Down
6 changes: 3 additions & 3 deletions src/NumberTheory/NmbThy.jl
Original file line number Diff line number Diff line change
Expand Up @@ -183,11 +183,11 @@ end
=#

@doc raw"""
factorisations(a::AbsNumFieldOrderElem{AbsSimpleNumField,AbsSimpleNumFieldElem}) -> Vector{Fac{OrdElem}}
factorizations(a::AbsNumFieldOrderElem{AbsSimpleNumField,AbsSimpleNumFieldElem}) -> Vector{Fac{OrdElem}}
Return all factorisations of $a$ into irreducibles.
Return all factorizations of $a$ into irreducibles.
"""
function factorisations(a::AbsNumFieldOrderElem{AbsSimpleNumField,AbsSimpleNumFieldElem})
function factorizations(a::AbsNumFieldOrderElem{AbsSimpleNumField,AbsSimpleNumFieldElem})
O = parent(a)
S = collect(keys(factor(a*O)))
if length(S) == 0
Expand Down
4 changes: 2 additions & 2 deletions src/TropicalGeometry/groebner_fan.jl
Original file line number Diff line number Diff line change
Expand Up @@ -426,8 +426,8 @@ function groebner_fan(I::MPolyIdeal;
# Starting cone
###
C = maximal_groebner_cone(G,ord,homogeneityWeight)
workingList = [(G,ord,C,unique_identifying_point(C))] # list of Groebner cones whose neighbours may be unknown
finishedList = typeof(workingList)() # list of Groebner cones whose neighbours are known
workingList = [(G,ord,C,unique_identifying_point(C))] # list of Groebner cones whose neighbors may be unknown
finishedList = typeof(workingList)() # list of Groebner cones whose neighbors are known
finishedFacets = Vector{Vector{ZZRingElem}}() # list of interior facet points whose facet has been traversed


Expand Down
2 changes: 1 addition & 1 deletion src/TropicalGeometry/hypersurface.jl
Original file line number Diff line number Diff line change
Expand Up @@ -142,7 +142,7 @@ Min tropical hypersurface
"""
function tropical_hypersurface(f::MPolyRingElem, nu::Union{Nothing,TropicalSemiringMap}=nothing;
weighted_polyhedral_complex_only::Bool=false)
# initialise nu as the trivial valuation if not specified by user
# initialize nu as the trivial valuation if not specified by user
isnothing(nu) && (nu=tropical_semiring_map(coefficient_ring(f)))

tropf = tropical_polynomial(f,nu)
Expand Down
8 changes: 4 additions & 4 deletions src/TropicalGeometry/linear_space.jl
Original file line number Diff line number Diff line change
Expand Up @@ -163,7 +163,7 @@ Min tropical linear space
```
"""
function tropical_linear_space(plueckerIndices::Vector{Vector{Int}}, plueckerVector::Vector, nu::Union{Nothing,TropicalSemiringMap}=nothing; weighted_polyhedral_complex_only::Bool=false)
# if nu unspecified, initialise as the trivial valuation + min convention
# if nu unspecified, initialize as the trivial valuation + min convention
isnothing(nu) && (nu=tropical_semiring_map(parent(first(plueckerVector))))

TropL = tropical_linear_space(plueckerIndices,
Expand Down Expand Up @@ -195,7 +195,7 @@ Min tropical linear space
```
"""
function tropical_linear_space(k::Int, n::Int, plueckerVector::Vector, nu::Union{Nothing,TropicalSemiringMap}=nothing; weighted_polyhedral_complex_only::Bool=false)
# if nu unspecified, initialise as the trivial valuation + min convention
# if nu unspecified, initialize as the trivial valuation + min convention
isnothing(nu) && (nu=tropical_semiring_map(parent(first(plueckerVector))))

TropL = tropical_linear_space(AbstractAlgebra.combinations(1:n,k), nu.(plueckerVector), weighted_polyhedral_complex_only=weighted_polyhedral_complex_only)
Expand Down Expand Up @@ -261,7 +261,7 @@ Min tropical linear space
```
"""
function tropical_linear_space(A::MatElem, nu::Union{Nothing,TropicalSemiringMap}=nothing; weighted_polyhedral_complex_only::Bool=false)
# if nu unspecified, initialise as the trivial valuation + min convention
# if nu unspecified, initialize as the trivial valuation + min convention
isnothing(nu) && (nu=tropical_semiring_map(base_ring(A)))

n = max(nrows(A), ncols(A))
Expand Down Expand Up @@ -302,7 +302,7 @@ Min tropical linear space
```
"""
function tropical_linear_space(I::MPolyIdeal, nu::Union{Nothing,TropicalSemiringMap}=nothing; weighted_polyhedral_complex_only::Bool=false)
# initialise nu as the trivial valuation if not specified by user
# initialize nu as the trivial valuation if not specified by user
isnothing(nu) && (nu=tropical_semiring_map(coefficient_ring(I)))

x = gens(base_ring(I))
Expand Down
30 changes: 15 additions & 15 deletions src/TropicalGeometry/variety.jl
Original file line number Diff line number Diff line change
Expand Up @@ -163,7 +163,7 @@ julia> tropical_variety(I)
function tropical_variety(I::Union{MPolyIdeal,MPolyRingElem}, nu::Union{TropicalSemiringMap,Nothing}=nothing; weighted_polyhedral_complex_only::Bool=false, skip_saturation::Bool=false, skip_primary_decomposition::Bool=false)
###
# Step 0.a: convert I to ideal if poly,
# initialise nu as the trivial valuation if not specified by user
# initialize nu as the trivial valuation if not specified by user
###
if I isa MPolyRingElem
I = ideal(parent(I),[I])
Expand Down Expand Up @@ -559,8 +559,8 @@ end
# # * w is a weight vector with respect to which G is a Groebner basis,
# # * w is compatible with coordinate permutations if symmetries exist,
# # * instead of comparing C or G it suffices to compare w.
# working_list_todo = [] # list of groebner polyhedra with potentially unknown neighbours
# working_list_done = [] # list of groebner polyhedra with known neighbours
# working_list_todo = [] # list of groebner polyhedra with potentially unknown neighbors
# working_list_done = [] # list of groebner polyhedra with known neighbors
# facet_points_done = [] # list of facet points whose tropical links were computed and traversed

# compute_starting_points = true
Expand Down Expand Up @@ -623,29 +623,29 @@ end

# directions_to_traverse = tropical_link(ideal(G),val,point_to_traverse) # todo, this output can be wrong
# for direction_to_traverse in directions_to_traverse
# # compute neighbour
# # compute neighbor
# print("computing groebner_basis for ",point_to_traverse,direction_to_traverse,"... ")
# G_neighbour = groebner_flip(G,val,w,point_to_traverse,direction_to_traverse)
# G_neighbor = groebner_flip(G,val,w,point_to_traverse,direction_to_traverse)
# println("done")
# C_neighbour = groebner_polyhedron(G_neighbour,val,point_to_traverse,perturbation=direction_to_traverse)
# w_neighbour = anchor_point(C_neighbour)
# C_neighbor = groebner_polyhedron(G_neighbor,val,point_to_traverse,perturbation=direction_to_traverse)
# w_neighbor = anchor_point(C_neighbor)

# # if neighbour is already in done list, skip
# # if neighbor is already in done list, skip
# i = searchsortedfirst(working_list_done,
# (w_neighbour,C_neighbour,G_neighbour),
# (w_neighbor,C_neighbor,G_neighbor),
# by=x->x[1])
# if i<=length(working_list_done) && working_list_done[i][1]==w_neighbour
# if i<=length(working_list_done) && working_list_done[i][1]==w_neighbor
# continue
# end
# # if neighbour is already in todo list, skip
# # if neighbor is already in todo list, skip
# i = searchsortedfirst(working_list_todo,
# (w_neighbour,C_neighbour,G_neighbour),
# (w_neighbor,C_neighbor,G_neighbor),
# by=x->x[1])
# if i<=length(working_list_todo) && working_list_todo[i][1]==w_neighbour
# if i<=length(working_list_todo) && working_list_todo[i][1]==w_neighbor
# continue
# end
# # otherwise, add neighbour to todo list
# insert!(working_list_todo, i, (w_neighbour,C_neighbour,G_neighbour))
# # otherwise, add neighbor to todo list
# insert!(working_list_todo, i, (w_neighbor,C_neighbor,G_neighbor))
# end
# end
# end
Expand Down
3 changes: 3 additions & 0 deletions src/deprecations.jl
Original file line number Diff line number Diff line change
Expand Up @@ -70,3 +70,6 @@ Base.@deprecate_binding jacobi_ideal jacobian_ideal
@deprecate has_number_small_groups has_number_of_small_groups
@deprecate number_transitive_groups number_of_transitive_groups
@deprecate has_number_transitive_groups has_number_of_transitive_groups

@deprecate factorisations factorizations
@deprecate centraliser centralizer
2 changes: 1 addition & 1 deletion src/exports.jl
Original file line number Diff line number Diff line change
Expand Up @@ -513,7 +513,7 @@ export facet_indices
export facet_sizes
export facets
export factor_of_direct_product
export factorisations
export factorizations
export fano_matroid
export fano_simplex
export fat_ideal
Expand Down
4 changes: 2 additions & 2 deletions test/NumberTheory/nmbthy.jl
Original file line number Diff line number Diff line change
Expand Up @@ -4,10 +4,10 @@ using Test
function evalu(x::Fac)
return x.unit * prod(p*k for (p,k) = x.fac)
end
@testset "Polymake.factorisations" begin
@testset "Polymake.factorizations" begin
k, a = quadratic_field(-5)
zk = maximal_order(k)
f = factorisations(zk(6))
f = factorizations(zk(6))
@test length(f) == 2
@test all(x -> evalu(x) == 6, f)
end
Expand Down

0 comments on commit d373a85

Please sign in to comment.