Skip to content

Commit

Permalink
implemented synodicmonth and jovianyear
Browse files Browse the repository at this point in the history
  • Loading branch information
chakravala committed May 5, 2022
1 parent 3b30a1c commit 2171519
Show file tree
Hide file tree
Showing 15 changed files with 368 additions and 101 deletions.
4 changes: 2 additions & 2 deletions Kernel/dimensions.wl
Original file line number Diff line number Diff line change
Expand Up @@ -98,8 +98,8 @@ Measure /: Subtract[a_,Measure[v_,d1,u_]] := Measure[a-v,d1,u]
Measure /: Times[Measure[v1_,d1_,u_],Measure[v2_,d2_,u_]] := Measure[v1*v2,d1*d2,u]
Measure /: Divide[Measure[v1_,d1_,u_],Measure[v2_,d2_,u_]] := Measure[v1/v2,d1/d2,u]
Measure /: Power[Measure[v_,d_,u_],b_] := Measure[v^b,d^b,u]
Measure /: Plus[Measure[v1_,d1_,u_],Measure[v2_,d2_,u_]] := Measure[v1+v2,d1+d2,u]
Measure /: Subtract[Measure[v1_,d1_,u_],Measure[v2_,d2_,u_]] := Measure[v1-v2,d1-d2,u]
Measure /: Plus[Measure[v1_,d_,u_],Measure[v2_,d_,u_]] := Measure[v1+v2,d,u]
Measure /: Subtract[Measure[v1_,d_,u_],Measure[v2_,d_,u_]] := Measure[v1-v2,d,u]
Measure /: Sqrt[Measure[v_,d_,u_]] := Measure[Sqrt[v],Sqrt[d],u]

Measure /: Equal[Measure[v_,USQ[l_,c_],u_],a_] := And[Total[l]==0,a==v*c]
Expand Down
4 changes: 2 additions & 2 deletions Kernel/physics.wl
Original file line number Diff line number Diff line change
Expand Up @@ -131,7 +131,7 @@ AngularMomentum[u_UnitSystem, s_UnitSystem] := Unit[Momentum[u, s] Length[u, s]
ForceOnsetRate[u_UnitSystem, s_UnitSystem] := Unit[Mass[u, s] Jerk[u, s]];
MassPerArea[u_UnitSystem, s_UnitSystem] := Unit[Mass[u, s]/Area[u, s]];
MassDensity[u_UnitSystem, s_UnitSystem] := Unit[Mass[u, s]/Volume[u, s]];
SpecificWeight[u_UnitSystem, s_UnitSystem] := Unit[Pressure[u, s]/Speed[u, s]^2];
SpecificWeight[u_UnitSystem, s_UnitSystem] := Unit[Force[u, s]/Volume[u, s]];
SpecificVolume[u_UnitSystem, s_UnitSystem] := Unit[Volume[u, s]/Mass[u, s]];
Action[u_UnitSystem, s_UnitSystem] := Unit[Energy[u, s] Time[u, s]];
(*Stiffness[u_UnitSystem, s_UnitSystem] := Unit[Force[u, s]/Length[u, s]];*)
Expand Down Expand Up @@ -258,7 +258,7 @@ Map[(#[u_UnitSystem] := #[u, Universe[u]]) &, {CosmologicalConstant, AvogadroCon
AvogadroConstant[u_UnitSystem, c_Coupling] := MolarMassConstant[u, c] ElectronRelativeAtomicMass[c]/ElectronMass[u, c];
AtomicMassConstant[u_UnitSystem, c_Coupling] := ElectronMass[u, c]/ElectronRelativeAtomicMass[c];
ProtonMass[u_UnitSystem, c_Coupling] := ProtonElectronMassRatio[c] ElectronMass[u, c];
GaussianGravitationalConstant[u_UnitSystem, c_Couling] = Sqrt[GravitationalConstant[u,c]]
GaussianGravitationalConstant[u_UnitSystem, c_Couling] = Measure[MM@Sqrt[GravitationalConstant[u,c]],dA/dT,"IAU"][u]
EinsteinConstantSpeedOfLightSquared[u_UnitSystem, c_Coupling] := (2 Spat[u] GravitationalConstant[u, c])/SpeedOfLight[u, c]^2;
EinsteinConstantSpeedOfLightToTheFourth[u_UnitSystem, c_Coupling] := (2 Spat[u] GravitationalConstant[u, c])/SpeedOfLight[u, c]^4;
MolarGasConstant[u_UnitSystem, c_Coupling] := BoltzmannConstant[u, c] AvogadroConstant[u, c];
Expand Down
10 changes: 9 additions & 1 deletion Kernel/standards.wl
Original file line number Diff line number Diff line change
Expand Up @@ -78,6 +78,13 @@ StandardUnits = <|
"Hour" -> Measure[60^2,dT,"Metric"],
"Day" -> Measure[1,dT,"IAU"],
"RadarMile" -> Measure[2,dL,"Nautical"]/SpeedOfLight["Nautical"],
"ips" -> Measure[1,dL/dT,"IPS"],
"fps" -> Measure[1,dL/dT,"British"],
"fpm" -> Measure[1,dL/dT,"British"],
"ms" -> Measure[1,dL/dT,"Metric"],
"kmh" -> Measure[1,dL/dT,"KKH"],
"mph" -> Measure[1,dL/dT,"MPH"],
"knot" -> Measure[1,dL/dT,"Nautical"],
"Barn" -> Measure[10^-28,dL^2,"Metric"],
"Hectare" -> Measure[Pre["hecto"] Pre["hecto"],dL^2,"Metric"],
"Acre" -> Measure[2^-7/5,dL^2,"MPH"],
Expand Down Expand Up @@ -173,7 +180,8 @@ StandardUnits = <|
"FootLambert" -> Measure[1/Pi,USQ[Luminance],"English"],
"Bril" -> Measure[Pre["centi"] Pre["nano"]/Pi,USQ[Luminance],"Gauss"],
"Hertz" -> Measure[1,d1/dT,"Metric"],
"RPM" -> Measure[1/60,d1/dT,"Metric"],
"APM" -> Measure[1/60,d1/dT,"Metric"],
"RPM" -> Measure[Pi/30,d1/dT,"Metric"],
"Galileo" -> Measure[1,USQ[SpecificForce],"Gauss"],
"Eotvos" -> Measure[Pre["nano"],USQ[SpecificForce]/dL,"Gauss"],
"Poise" -> Measure[1,USQ[DynamicViscosity],"Gauss"],
Expand Down
2 changes: 1 addition & 1 deletion Project.toml
Original file line number Diff line number Diff line change
@@ -1,7 +1,7 @@
name = "UnitSystems"
uuid = "3a241a3c-2137-41aa-af5e-1388e404ca09"
authors = ["Michael Reed"]
version = "0.3.4"
version = "0.3.5"

[deps]
LinearAlgebra = "37e2e46d-f89d-539d-b4ee-838fcccc9c8e"
Expand Down
2 changes: 1 addition & 1 deletion README.md
Original file line number Diff line number Diff line change
Expand Up @@ -49,7 +49,7 @@ additional constants `molarmass`, `luminousefficacy`, `gravity`, `angle`, `turn`

Physics constant documentation is at https://geophysics.crucialflow.com/dev/constants

Standardized unit/derived quantities are `hyperfine`, `loschmidt`, `wienwavelength`, `wienfrequency`, `mechanicalheat`, `solarmass`, `jupitermass`, `earthmass`, `lunarmass`, `earthradius`, `greatcircle`, `radarmile`, `hubble`, `cosmological`, `radian`, `steradian`, `degree`, `gradian`, `arcminute`, `arcsecond`, `second`, `minute`, `hour`, `day`, `year`, `gaussianyear`, `siderealyear`, `angstrom`, `inch`, `foot`, `surveyfoot`, `yard`, `meter`, `earthmeter`, `mile`, `statutemile`, `meridianmile`, `admiraltymile`, `nauticalmile`, `lunardistance`, `astronomicalunit`, `lightyear`, `parsec`, `barn`, `hectare`, `acre`, `surveyacre`, `liter`, `gallon`, `quart`, `pint`, `cup`, `fluidounce`, `teaspoon`, `tablespoon`, `grain`, `gram`, `earthgram`, `kilogram`, `tonne`, `ton`, `pound`, `ounce`, `slug`, `slinch`, `hyl`, `dyne`, `newton`, `poundal`, `poundforce`, `kilopond`, `psi`, `pascal`, `bar`, `barye`, `technicalatmosphere`, `atmosphere`, `inchmercury`, `torr`, `electronvolt`, `erg`, `joule`, `footpound`, `calorie`, `kilocalorie`, `meancalorie`, `earthcalorie`, `thermalunit`, `gasgallon`, `tontnt`, `watt`, `horsepower`, `horsepowerwatt`, `horsepowermetric`, `electricalhorsepower`, `tonsrefrigeration`, `boilerhorsepower`, `coulomb`, `earthcoulomb`, `ampere`, `volt`, `henry`, `ohm`, `siemens`, `farad`, `weber`, `tesla`, `abcoulomb`, `abampere`, `abvolt`, `abhenry`, `abohm`, `abmho`, `abfarad`, `maxwell`, `gauss`, `oersted`, `gilbert`, `statcoulomb`, `statampere`, `statvolt`, `stathenry`, `statohm`, `statmho`, `statfarad`, `statweber`, `stattesla`, `kelvin`, `rankine`, `celsius`, `fahrenheit`, `sealevel`, `boiling`, `mole`, `earthmole`, `poundmole`, `slugmole`, `slinchmole`, `katal`, `amagat`, `lumen`, `candela`, `lux`, `phot`, `footcandle`, `nit`, `apostilb`, `stilb`, `lambert`, `footlambert`, `bril`, `neper`, `bel`, `decibel`, `hertz`, `rpm`, `kayser`, `diopter`, `bubnoff`, `gforce`, `galileo`, `eotvos`, `darcy`, `poise`, `reyn`, `stokes`, `rayl`, `mpge`, `langley`, `jansky`, `solarflux`, `curie`, `sievert`, `roentgen`, `rem`.
Standardized unit/derived quantities are `hyperfine`, `loschmidt`, `wienwavelength`, `wienfrequency`, `mechanicalheat`, `solarmass`, `jupitermass`, `earthmass`, `lunarmass`, `earthradius`, `greatcircle`, `radarmile`, `hubble`, `cosmological`, `radian`, `steradian`, `degree`, `gradian`, `arcminute`, `arcsecond`, `second`, `minute`, `hour`, `day`, `gaussianmonth`, `siderealmonth`, `synodicmonth`, `year`, `gaussianyear`, `siderealyear`, `jovianyear`, `angstrom`, `inch`, `foot`, `surveyfoot`, `yard`, `meter`, `earthmeter`, `mile`, `statutemile`, `meridianmile`, `admiraltymile`, `nauticalmile`, `lunardistance`, `astronomicalunit`, `jupiterdistance`, `lightyear`, `parsec`, `bubnoff`, `ips`, `fps`, `fpm`, `ms`, `kmh`, `mph`, `knot`, `mps`, `barn`, `hectare`, `acre`, `surveyacre`, `liter`, `gallon`, `quart`, `pint`, `cup`, `fluidounce`, `teaspoon`, `tablespoon`, `grain`, `gram`, `earthgram`, `kilogram`, `tonne`, `ton`, `pound`, `ounce`, `slug`, `slinch`, `hyl`, `dyne`, `newton`, `poundal`, `poundforce`, `kilopond`, `psi`, `pascal`, `bar`, `barye`, `technicalatmosphere`, `atmosphere`, `inchmercury`, `torr`, `electronvolt`, `erg`, `joule`, `footpound`, `calorie`, `kilocalorie`, `meancalorie`, `earthcalorie`, `thermalunit`, `gasgallon`, `tontnt`, `watt`, `horsepower`, `horsepowerwatt`, `horsepowermetric`, `electricalhorsepower`, `tonsrefrigeration`, `boilerhorsepower`, `coulomb`, `earthcoulomb`, `ampere`, `volt`, `henry`, `ohm`, `siemens`, `farad`, `weber`, `tesla`, `abcoulomb`, `abampere`, `abvolt`, `abhenry`, `abohm`, `abmho`, `abfarad`, `maxwell`, `gauss`, `oersted`, `gilbert`, `statcoulomb`, `statampere`, `statvolt`, `stathenry`, `statohm`, `statmho`, `statfarad`, `statweber`, `stattesla`, `kelvin`, `rankine`, `celsius`, `fahrenheit`, `sealevel`, `boiling`, `mole`, `earthmole`, `poundmole`, `slugmole`, `slinchmole`, `katal`, `amagat`, `lumen`, `candela`, `lux`, `phot`, `footcandle`, `nit`, `apostilb`, `stilb`, `lambert`, `footlambert`, `bril`, `neper`, `bel`, `decibel`, `hertz`, `apm`, `rpm`, `kayser`, `diopter`, `gforce`, `galileo`, `eotvos`, `darcy`, `poise`, `reyn`, `stokes`, `rayl`, `mpge`, `langley`, `jansky`, `solarflux`, `curie`, `sievert`, `roentgen`, `rem`.

Standard physics units are at https://geophysics.crucialflow.com/dev/units

Expand Down
12 changes: 7 additions & 5 deletions src/UnitSystems.jl
Original file line number Diff line number Diff line change
Expand Up @@ -24,10 +24,11 @@ const Constants = (:lightspeed,:planck,:planckreduced,:electronmass,:molarmass,:
const Physics = (:turn,:spat,:atomicmass,:protonmass,:planckmass,:gravitation,:gaussgravitation,:einstein,:hartree,:rydberg,:bohr,:electronradius,:avogadro,:molargas,:stefan,:radiationdensity,:vacuumpermeability,:vacuumpermittivity,:electrostatic,:magnetostatic,:biotsavart,:elementarycharge,:faraday,:vacuumimpedance,:conductancequantum,:klitzing,:josephson,:magneticfluxquantum,:magneton)
const Derived = (:hyperfine,:loschmidt,:wienwavelength,:wienfrequency,:mechanicalheat,:solarmass,:jupitermass,:earthmass,:lunarmass,:earthradius,:greatcircle,:radarmile,:hubble,:cosmological,
:radian,:steradian,:degree,:gradian,:arcminute,:arcsecond,
:second,:minute,:hour,:day,:year,:gaussianyear,:siderealyear,
:angstrom,:inch,:foot,:surveyfoot,:yard,:meter,:earthmeter,:mile,:statutemile,:meridianmile,:admiraltymile,:nauticalmile,:lunardistance,:astronomicalunit,:lightyear,:parsec,
:second,:minute,:hour,:day,:gaussianmonth,:siderealmonth,:synodicmonth,:year,:gaussianyear,:siderealyear,:jovianyear,
:angstrom,:inch,:foot,:surveyfoot,:yard,:meter,:earthmeter,:mile,:statutemile,:meridianmile,:admiraltymile,:nauticalmile,:lunardistance,:astronomicalunit,:jupiterdistance,:lightyear,:parsec,
:barn,:hectare,:acre,:surveyacre,
:liter,:gallon,:quart,:pint,:cup,:fluidounce,:teaspoon,:tablespoon,
:bubnoff,:ips,:fps,:fpm,:ms,:kmh,:mph,:knot,:mps,
:grain,:gram,:earthgram,:kilogram,:tonne,:ton,:pound,:ounce,:slug,:slinch,:hyl,
:dyne,:newton,:poundal,:poundforce,:kilopond,
:psi,:pascal,:bar,:barye,:technicalatmosphere,:atmosphere,:inchmercury,:torr,
Expand All @@ -38,8 +39,8 @@ const Derived = (:hyperfine,:loschmidt,:wienwavelength,:wienfrequency,:mechanica
:statcoulomb,:statampere,:statvolt,:stathenry,:statohm,:statmho,:statfarad,:statweber,:stattesla,
:kelvin,:rankine,:celsius,:fahrenheit,:sealevel,:boiling,:mole,:earthmole,:poundmole,:slugmole,:slinchmole,:katal,:amagat,
:lumen,:candela,:lux,:phot,:footcandle,:nit,:apostilb,:stilb,:lambert,:footlambert,:bril,
:neper,:bel,:decibel,:hertz,:rpm,
:kayser,:diopter,:bubnoff,:gforce,:galileo,:eotvos,:darcy,:poise,:reyn,:stokes,:rayl,
:neper,:bel,:decibel,:hertz,:apm,:rpm,
:kayser,:diopter,:gforce,:galileo,:eotvos,:darcy,:poise,:reyn,:stokes,:rayl,
:mpge,:langley,:jansky,:solarflux,:curie,:sievert,:roentgen,:rem)
const Kinematic = (:solidangle,:time,:length,:area,:volume,:wavenumber,:angularwavenumber,:fuelefficiency,:numberdensity,:frequency,:angularfrequency,:frequencydrift,:speed,:acceleration,:jerk,:snap,:crackle,:pop,:volumeflow) #angle
const Mechanical = (:inertia,:mass,:massflow,:lineardensity,:areadensity,:density,:specificweight,:specificvolume,:force,:specificforce,:gravityforce,:pressure,:compressibility,:viscosity,:diffusivity,:rotationalinertia,:impulse,:momentum,:angularmomentum,:yank,:energy,:specificenergy,:action,:fluence,:power,:powerdensity,:intensity,:spectralflux,:soundexposure,:impedance,:specificimpedance,:admittance,:compliance,:inertance)
Expand Down Expand Up @@ -314,7 +315,8 @@ const RK1990,KJ1990,Rᵤ2014 = Constant(25812.807),Constant(4.835979e14),Constan
const RK2014,KJ2014 = Constant(25812.8074555),Constant(4.835978525e14)
const GME,GMJ = Constant(398600441.8e6),Constant(1.26686534e17)
const kG,H0,ΩΛ = Constant(3548.18761),Constant(67.66),Constant(0.6889)
const aⱼ,au,LD = Constant(365.25),Constant(149597870.7e3),Constant(384402e3)
const aⱼ,au = Constant(365.25),Constant(149597870.7e3)
const LD,JD = Constant(384399e3),Constant(778479e6)
const zetta,zepto = Constant(1e21),Constant(1e-21)
const yotta,yocto = Constant(1e24),Constant(1e-24)
const 𝟏,𝟐,𝟑,𝟓,𝟕,𝟏𝟎,𝟏𝟏,𝟏𝟗,𝟒𝟑,τ,α = Constant(1),Constant(2),Constant(3),Constant(5),Constant(7),Constant(10),Constant(11),Constant(19),Constant(43),Constant(2π),inv(αinv)
Expand Down
1 change: 1 addition & 0 deletions src/constant.jl
Original file line number Diff line number Diff line change
Expand Up @@ -40,6 +40,7 @@ Base.:/(a::Number,b::Constant) = a*inv(b)
Base.:/(a::Constant,b::Number) = a*inv(b)
Base.inv(a::Constant{D}) where D = Constant{inv(D)}()
Base.sqrt(a::Constant{D}) where D = Constant{sqrt(D)}()
Base.cbrt(a::Constant{D}) where D = Constant{cbrt(D)}()
Base.log(x::Constant{D}) where D = Constant{log(D)}()
Base.log2(x::Constant{D}) where D = Constant{log2(D)}()
Base.log10(x::Constant{D}) where D = Constant{log10(D)}()
Expand Down
20 changes: 16 additions & 4 deletions src/derived.jl
Original file line number Diff line number Diff line change
Expand Up @@ -21,8 +21,8 @@
@pure arcminute(U::UnitSystem) = degree(U)/two(U)^2/three(U)/five(U)
@pure arcsecond(U::UnitSystem) = arcminute(U)/two(U)^2/three(U)/five(U)

@pure rpm(U::UnitSystem) = one(U)/minute(U)
#@pure rpd(U::UnitSystem) = turn(U)/day(U)
@pure apm(U::UnitSystem) = one(U)/minute(U)
@pure rpm(U::UnitSystem) = turn(U)/minute(U)

# time

Expand Down Expand Up @@ -52,7 +52,8 @@
@pure nauticalmile(U::UnitSystem) = length(one(U),U,Nautical)
#@pure navigationmile(U::UnitSystem) = greatcircle(U)/two(U)^5/three(U)^3/five(U)^2
@pure astronomicalunit(U::UnitSystem) = length(𝟏,U,IAU)
@pure lunardistance(U::UnitSystem) = length(LD,U,Metric)
@pure lunardistance(U::UnitSystem) = length(𝟏,U,IAUE)
@pure jupiterdistance(U::UnitSystem) = length(𝟏,U,IAUJ)
@pure mile(U::UnitSystem) = length(two(U)^5*three(U)*five(U)*eleven(U),U,English)
@pure admiraltymile(U::UnitSystem) = length(two(U)^6*five(U)*nineteen(U),U,English)
@pure meridianmile(U::UnitSystem) = length(two(U)^4*five(U)^5/three(U)^3,U,Metric)
Expand Down Expand Up @@ -80,6 +81,18 @@
@pure tablespoon(U::UnitSystem) = three(U)*teaspoon(U)
#@pure oilbarrel(U::UnitSystem) = two(U)*three(U)*seven(U)*gallon(U)

# speed

@pure bubnoff(U::UnitSystem) = meter(U)/year(U)
@pure ips(U::UnitSystem) = inch(U)/second(U)
@pure fps(U::UnitSystem) = foot(U)/second(U)
@pure fpm(U::UnitSystem) = foot(U)/minute(U)
@pure ms(U::UnitSystem) = meter(U)/second(U)
@pure kmh(U::UnitSystem) = kilo(U)*meter(U)/hour(U)
@pure mph(U::UnitSystem) = mile(U)/hour(U)
@pure knot(U::UnitSystem) = nauticalmile(U)/hour(U)
@pure mps(U::UnitSystem) = mile(U)/second(U)

# mass

@pure grain(U::UnitSystem) = milli(U)*pound(U)/seven(U)
Expand Down Expand Up @@ -212,7 +225,6 @@
@pure hertz(U::UnitSystem) = one(U)/second(U)
@pure kayser(U::UnitSystem) = wavenumber(one(U),U,Gauss)
@pure diopter(U::UnitSystem) = wavenumber(one(U),U,Metric)
@pure bubnoff(U::UnitSystem) = meter(U)/year(U)
@pure gforce(U::UnitSystem) = specificforce(one(U),U,English)
@pure galileo(U::UnitSystem) = specificforce(one(U),U,Gauss)
@pure eotvos(U::UnitSystem) = specificforce(nano(U),U,Gauss)/length(one(U),U,Gauss)
Expand Down
191 changes: 172 additions & 19 deletions src/derivedocs.jl
Original file line number Diff line number Diff line change
Expand Up @@ -428,7 +428,7 @@ $(astronomicalunit(Metric)/lightspeed(Metric))
""" astronomicalunit, au

@doc """
$(unitext(:lunardistance,"length($LD,U,Metric)"))
$(unitext(:lunardistance,"length(𝟏,U,IAUE)"))
Standard distance between the Earth and the Moon (m or ft).
```Julia
Expand All @@ -443,6 +443,22 @@ $(lunardistance(Metric)/lightspeed(Metric))
```
""" lunardistance, LD

@doc """
$(unitext(:jupiterdistance,"length(𝟏,U,IAUJ)"))
Standard distance between the Sun and the planet Jupiter (m or ft).
```Julia
julia> jupiterdistance(Metric) # m
$(jupiterdistance(Metric))
julia> jupiterdistance(IAU) # au
$(jupiterdistance(IAU))
julia> jupiterdistance(Metric)/lightspeed(Metric) # s
$(jupiterdistance(Metric)/lightspeed(Metric))
```
""" jupiterdistance, JD

@doc """
$(unitext(:mile,"length(𝟏,U,MPH)"))
Expand Down Expand Up @@ -735,6 +751,146 @@ $(tablespoon(IPS))
```
""" tablespoon

# speed

@doc """
$(unitext(:bubnoff,"meter(U)/year(U)"))
Reference unit of erosion `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> bubnoff(CGS) # cm⋅s⁻¹
$(bubnoff(CGS))
julia> bubnoff(English) # ft⋅s⁻¹
$(bubnoff(English))
```
""" bubnoff

@doc """
$(unitext(:ips,"inch(U)/second(U)"))
Inch per second unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> ips(CGS) # cm⋅s⁻¹
$(ips(CGS))
julia> ips(English) # ft⋅s⁻¹
$(ips(English))
```
""" ips

@doc """
$(unitext(:fps,"feet(U)/second(U)"))
Feet per second unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> fps(Metric) # m⋅s⁻¹
$(fps(Metric))
julia> fps(KKH) # km⋅h⁻¹
$(fps(KKH))
julia> fps(MPH) # mi⋅h⁻¹
$(fps(MPH))
```
""" fps

@doc """
$(unitext(:fpm,"feet(U)/minute(U)"))
Feet per minute unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> fpm(CGS) # cm⋅s⁻¹
$(fpm(CGS))
julia> fpm(IPS) # in⋅s⁻¹
$(fpm(IPS))
julia> fpm(English) # ft⋅s⁻¹
$(fpm(English))
```
""" fpm

@doc """
$(unitext(:ms,"meter(U)/second(U)"))
Meters per second unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> ms(KKH) # km⋅h⁻¹
$(ms(KKH))
julia> ms(MPH) # mi⋅h⁻¹
$(ms(MPH))
julia> ms(Nautical) # nm⋅h⁻¹
$(ms(Nautical))
```
""" ms

@doc """
$(unitext(:kmh,"kilo(U)*meter(U)/hour(U)"))
Kilometers per hour unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> kmh(Metric) # m⋅s⁻¹
$(kmh(Metric))
julia> kmh(MPH) # mi⋅h⁻¹
$(kmh(MPH))
julia> kmh(Nautical) # nm⋅h⁻¹
$(kmh(Nautical))
```
""" kmh

@doc """
$(unitext(:mph,"mile(U)/hour(U)"))
Miles per hour unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> mph(Metric) # m⋅s⁻¹
$(mph(Metric))
julia> mph(KKH) # km⋅h⁻¹
$(mph(KKH))
julia> mph(Nautical) # nm⋅h⁻¹
$(mph(Nautical))
```
""" mph

@doc """
$(unitext(:knot,"nauticalmile(U)/hour(U)"))
Nautical miles per hour unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> knot(Metric) # m⋅s⁻¹
$(knot(Metric))
julia> knot(KKH) # km⋅h⁻¹
$(knot(KKH))
julia> knot(MPH) # mi⋅h⁻¹
$(knot(MPH))
```
""" knot

@doc """
$(unitext(:mps,"mile(U)/second(U)"))
Miles per second unit of `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> mps(KKH) # km⋅h⁻¹
$(mps(KKH))
julia> mps(MPH) # mi⋅h⁻¹
$(mps(MPH))
julia> mps(Nautical) # nm⋅h⁻¹
$(mps(Nautical))
```
""" mps

# mass

@doc """
Expand Down Expand Up @@ -2417,9 +2573,22 @@ $(hertz(IAU))
""" hertz

@doc """
$(unitext(:rpm,"𝟏/minute(U)"))
$(unitext(:apm,"𝟏/minute(U)"))
Actions per minute `apm` unit of `frequency` (s⁻¹).
```Julia
julia> apm(MetricEngineering) # s⁻¹
$(apm(MetricEngineering))
julia> apm(IAU) # D⁻¹
$(apm(IAU))
```
""" apm

@doc """
$(unitext(:rpm,"turn(U)/minute(U)"))
Engineering unit of `frequency` (s⁻¹).
Revolutions per minute `rpm` unit of `angularfrequency` (s⁻¹).
```Julia
julia> rpm(MetricEngineering) # rad⋅s⁻¹
$(rpm(MetricEngineering))
Expand Down Expand Up @@ -2461,22 +2630,6 @@ $(diopter(English))
```
""" diopter

@doc """
$(unitext(:bubnoff,"meter(U)/year(U)"))
Reference unit of erosion `speed` (m⋅s⁻¹ or ft⋅s⁻¹).
```Julia
julia> bubnoff(Metric) # m⋅s⁻¹
$(bubnoff(Metric))
julia> bubnoff(CGS) # cm⋅s⁻¹
$(bubnoff(CGS))
julia> bubnoff(English) # ft⋅s⁻¹
$(bubnoff(English))
```
""" bubnoff

@doc """
$(unitext(:gforce,"specificforce(𝟏,U,English)"))
Expand Down
Loading

2 comments on commit 2171519

@chakravala
Copy link
Owner Author

Choose a reason for hiding this comment

The reason will be displayed to describe this comment to others. Learn more.

@JuliaRegistrator register()

@JuliaRegistrator
Copy link

Choose a reason for hiding this comment

The reason will be displayed to describe this comment to others. Learn more.

Registration pull request created: JuliaRegistries/General/59701

After the above pull request is merged, it is recommended that a tag is created on this repository for the registered package version.

This will be done automatically if the Julia TagBot GitHub Action is installed, or can be done manually through the github interface, or via:

git tag -a v0.3.5 -m "<description of version>" 21715195698bf2beee05e9b69cd15f4a1497e62e
git push origin v0.3.5

Please sign in to comment.