diff --git a/Project.toml b/Project.toml index e40c848..372f2e0 100644 --- a/Project.toml +++ b/Project.toml @@ -1,7 +1,7 @@ name = "SatelliteDynamics" uuid = "0e7c1a32-1b9f-5532-88a4-e668712d6a4c" authors = ["Duncan Eddy "] -version = "0.2.2" +version = "0.3.0" [deps] Dates = "ade2ca70-3891-5945-98fb-dc099432e06a" diff --git a/README.md b/README.md index a95fa10..55ae0ea 100644 --- a/README.md +++ b/README.md @@ -30,4 +30,11 @@ using SatelliteDynamics The documentation for the package can be found here: -More example code and more thorough documentation will be added as time permits. \ No newline at end of file +More example code and more thorough documentation will be added as time permits. + +## Development Roadmap + +These are currently features lacking from SatelliteDynamics, but being considered +for future development. Please feel free to leave feedback or comments here: + +[Future Feature List](https://github.com/sisl/SatelliteDynamics.jl/issues/4) \ No newline at end of file diff --git a/src/SatelliteDynamics.jl b/src/SatelliteDynamics.jl index b677c21..091915f 100644 --- a/src/SatelliteDynamics.jl +++ b/src/SatelliteDynamics.jl @@ -2,7 +2,17 @@ __precompile__(true) module SatelliteDynamics # Usings -using Reexport +using Dates +using Printf +using LinearAlgebra +using SOFA + +using StaticArrays: SVector, SMatrix + +# Define constants for array indexing +const idx1t3 = SVector(1, 2, 3) +const idx4t6 = SVector(4, 5, 6) +const idx1t6 = SVector(1, 2, 3, 4, 5, 6) # Includes include("constants.jl") @@ -15,17 +25,6 @@ include("astrodynamics.jl") include("orbit_dynamics.jl") include("sgp_models.jl") -# Export Values -@reexport using SatelliteDynamics.Constants -@reexport using SatelliteDynamics.Universe -@reexport using SatelliteDynamics.Time -@reexport using SatelliteDynamics.ReferenceSystems -@reexport using SatelliteDynamics.Attitude -@reexport using SatelliteDynamics.Coordinates -@reexport using SatelliteDynamics.Astrodynamics -@reexport using SatelliteDynamics.OrbitDynamics -@reexport using SatelliteDynamics.SGPModels - # Export EarthEnvironment submodule include(joinpath(".", "earth_environment", "earth_environment.jl")) include(joinpath(".", "simulation", "simulation.jl")) diff --git a/src/astrodynamics.jl b/src/astrodynamics.jl index 33e06ca..b96bdf7 100644 --- a/src/astrodynamics.jl +++ b/src/astrodynamics.jl @@ -1,11 +1,3 @@ -__precompile__(true) -module Astrodynamics - - -using LinearAlgebra -using SatelliteDynamics.Constants: GM_EARTH, R_EARTH, J2_EARTH - - export mean_motion """ Compute the mean motion given a semi-major axis. @@ -13,7 +5,7 @@ Compute the mean motion given a semi-major axis. Arguments: - `a::Real`: Semi-major axis. [m] - `use_degrees:Bool`: If `true` returns result in units of degrees -- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.Constants.GM_EARTH` if none is provided. +- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.GM_EARTH` if none is provided. Returns: - `n::Real`: Orbital mean motion. [rad/s] or [deg/s] @@ -35,7 +27,7 @@ Calculate semi-major axis given mean-motion. Arguments: - `n::Real`: Orbital mean motion. [rad/s] or [deg/s] - `use_degrees:Bool`: If `true` interpret input as being in degrees. -- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.Constants.GM_EARTH` if none is provided. +- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.GM_EARTH` if none is provided. Returns: - `a::Real`: Semi-major axis. [m] @@ -56,7 +48,7 @@ Compute the satellite orbital period given the semi-major axis. Arguments: - `a::Real`: Semi-major axis. [m] -- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.Constants.GM_EARTH` if none is provided. +- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.GM_EARTH` if none is provided. Returns: - `T::Real`: Orbital period. [s] @@ -193,7 +185,7 @@ The osculating elements are assumed to be (in order): Arguments: - x_oe `x::Array{<:Real, 1}`: Osculating orbital elements. See above for desription of the elements and their required order. - `use_degrees:Bool`: If `true` interpret input will be interpreted as being in degrees, and output will be returned in degrees. -- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.Constants.GM_EARTH` if none is provided. +- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.GM_EARTH` if none is provided. # Returns - x `x::Array{<:Real, 1}`: Cartesean inertial state. Returns position and velocity. [m; m/s] @@ -248,7 +240,7 @@ The osculating elements are assumed to be (in order): Arguments: - x `x::Array{<:Real, 1}`: Cartesean inertial state. Returns position and velocity. [m; m/s] - `use_degrees:Bool`: If `true` interpret input will be interpreted as being in degrees, and output will be returned in degrees. -- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.Constants.GM_EARTH` if none is provided. +- `GM::Real`: Gravitational constant of central body. Defaults to `SatelliteDynamics.GM_EARTH` if none is provided. # Returns - x_oe `x::Array{<:Real, 1}`: Osculating orbital elements. See above for desription of the elements and their required order. @@ -299,6 +291,4 @@ function sCARTtoOSC(x::Array{<:Real, 1}; use_degrees::Bool=false, GM::Real=GM_EA end return x_oe -end - end \ No newline at end of file diff --git a/src/attitude.jl b/src/attitude.jl index 4e5a3a5..7c9e39f 100644 --- a/src/attitude.jl +++ b/src/attitude.jl @@ -1,8 +1,3 @@ -__precompile__(true) -module Attitude - -using LinearAlgebra - ############# # Rotations # ############# @@ -835,6 +830,4 @@ end #################### # Type Conversions # -#################### - -end # End module Coordinates \ No newline at end of file +#################### \ No newline at end of file diff --git a/src/constants.jl b/src/constants.jl index 61592ee..55be23f 100644 --- a/src/constants.jl +++ b/src/constants.jl @@ -1,6 +1,3 @@ -__precompile__(true) -module Constants - # Mathematical Constants export RAD2DEG """ @@ -307,6 +304,4 @@ Gravitational constant of the Pluto. [m^3/s^2] O. Montenbruck, and E. Gill, _Satellite Orbits: Models, Methods and Applications_, 2012. """ -const GM_PLUTO = 977.000000*1e9 - -end \ No newline at end of file +const GM_PLUTO = 977.000000*1e9 \ No newline at end of file diff --git a/src/coordinates.jl b/src/coordinates.jl index 24adbd7..9444992 100644 --- a/src/coordinates.jl +++ b/src/coordinates.jl @@ -1,10 +1,3 @@ -__precompile__(true) -module Coordinates - -using LinearAlgebra - -using SatelliteDynamics.Constants: WGS84_a, WGS84_f - #################### # Helper Constants # #################### @@ -663,6 +656,4 @@ function sSEZtoAZEL(x::Array{<:Real, 1} ; use_degrees::Bool=false) else return azel end -end - end \ No newline at end of file diff --git a/src/earth_environment/earth_environment.jl b/src/earth_environment/earth_environment.jl index 72d4eb2..0e616ed 100644 --- a/src/earth_environment/earth_environment.jl +++ b/src/earth_environment/earth_environment.jl @@ -1,13 +1,3 @@ -__precompile__(true) -module EarthEnvironment - -using Reexport - # EarthEnvironment submodules include("space_weather.jl") -include("nrlmsise00.jl") - -@reexport using SatelliteDynamics.EarthEnvironment.SpaceWeather -@reexport using SatelliteDynamics.EarthEnvironment.NRLMSISE00 - -end # EarthEnvironment Module \ No newline at end of file +include("nrlmsise00.jl") \ No newline at end of file diff --git a/src/earth_environment/nrlmsise00.jl b/src/earth_environment/nrlmsise00.jl index d6fe8da..dc7561f 100644 --- a/src/earth_environment/nrlmsise00.jl +++ b/src/earth_environment/nrlmsise00.jl @@ -1,16 +1,7 @@ -__precompile__(true) -module NRLMSISE00 -""" -Julia NRLMSISE00 implementation is Dominik Brodowski's C implmenation adapted -for Julia. - -Ref: https://www.brodo.de/space/nrlmsise/ -""" - -using Printf -using SatelliteDynamics.Time: Epoch, mjd, day_of_year -using SatelliteDynamics.Coordinates: sECEFtoGEOD -using SatelliteDynamics.EarthEnvironment.SpaceWeather +# Julia NRLMSISE00 implementation is Dominik Brodowski's C implmenation adapted +# for Julia. +# +# Ref: https://www.brodo.de/space/nrlmsise/ ############## # Model Data # @@ -1680,6 +1671,4 @@ function density_nrlmsise00(epc::Epoch, x::Array{<:Real, 1}; use_degrees::Bool=f # Return local density rho = output.d[6] return rho -end - -end # NRLMSISE00 Module \ No newline at end of file +end \ No newline at end of file diff --git a/src/earth_environment/space_weather.jl b/src/earth_environment/space_weather.jl index 4822c85..6f98db9 100644 --- a/src/earth_environment/space_weather.jl +++ b/src/earth_environment/space_weather.jl @@ -1,9 +1,3 @@ -__precompile__(true) -module SpaceWeather - -# Julia Imports -using SatelliteDynamics.Time: caldate_to_mjd, Epoch, mjd - ########################## # Geomagnetic Index Data # ########################## @@ -379,6 +373,4 @@ function f107AdjustedAvg(solarflux::SolarFluxData, mjd::Real) end f107AdjustedAvg(mjd::Real) = f107AdjustedAvg(SOLAR_FLUX_DATA, mjd) -f107AdjustedAvg(epc::Epoch) = f107AdjustedAvg(SOLAR_FLUX_DATA, mjd(epc, tsys="UT1")) - -end # SpaceWeather \ No newline at end of file +f107AdjustedAvg(epc::Epoch) = f107AdjustedAvg(SOLAR_FLUX_DATA, mjd(epc, tsys="UT1")) \ No newline at end of file diff --git a/src/orbit_dynamics.jl b/src/orbit_dynamics.jl index d9f4139..6af3629 100644 --- a/src/orbit_dynamics.jl +++ b/src/orbit_dynamics.jl @@ -1,14 +1,3 @@ -__precompile__(true) -module OrbitDynamics - -using SatelliteDynamics.Constants -using SatelliteDynamics.Universe -using SatelliteDynamics.Time: Epoch, mjd -using SatelliteDynamics.Coordinates: sECEFtoGEOD -using SatelliteDynamics.Attitude: Rx, Ry, Rz -using SatelliteDynamics.ReferenceSystems -using LinearAlgebra - ##################### # Utility Functions # ##################### @@ -65,8 +54,8 @@ Assumes the satellite is much, much less massive than the central body. Arguments: - `r_sat::Array{<:Real, 1}`: satellite position in a commonn inertial frame [m] - `r_body::Array{<:Real, 1}`: position of body in a commonn inertial frame [m] -- `GM::Array{<:Real, 1}`: gravitational coeffient of attracting body [m^3/s^2] Default: SatelliteDynamics.Constants.GM_EARTH) -(Default: SatelliteDynamics.Constants.GM_EARTH +- `GM::Array{<:Real, 1}`: gravitational coeffient of attracting body [m^3/s^2] Default: SatelliteDynamics.GM_EARTH) +(Default: SatelliteDynamics.GM_EARTH Return: - `a::Array{<:Real, 1}`: Acceleration in X, Y, and Z inertial directions [m/s^2] @@ -91,8 +80,8 @@ of a massive body. Returns the acceleration vector of the satellite. Arguments: - `r_sat::Array{<:Real, 1}`: satellite position in the inertial frame [m] -- `GM::Array{<:Real, 1}`: gravitational coeffient of attracting body [m^3/s^2] Default: SatelliteDynamics.Constants.GM_EARTH) -(Default: SatelliteDynamics.Constants.GM_EARTH +- `GM::Array{<:Real, 1}`: gravitational coeffient of attracting body [m^3/s^2] Default: SatelliteDynamics.GM_EARTH) +(Default: SatelliteDynamics.GM_EARTH Return: - `a::Array{<:Real, 1}`: Acceleration in X, Y, and Z inertial directions [m/s^2] @@ -738,6 +727,4 @@ function accel_relativity(x::Array{<:Real, 1}) a_rel = GM_EARTH/r2 * ( (4*GM_EARTH/(c2*norm_r) - v2/c2)*er + 4*v2/c2*dot(er, ev)*ev) return a_rel -end - end \ No newline at end of file diff --git a/src/reference_systems.jl b/src/reference_systems.jl index 18a2efc..9ff50b9 100644 --- a/src/reference_systems.jl +++ b/src/reference_systems.jl @@ -1,20 +1,3 @@ -__precompile__(true) -module ReferenceSystems - -using LinearAlgebra - -using StaticArrays: SVector, SMatrix - -using SOFA -using SatelliteDynamics.Constants -using SatelliteDynamics.Universe: UT1_UTC, POLE_LOCATOR -using SatelliteDynamics.Time: Epoch, mjd - -const idx1t3 = SVector(1, 2, 3) -const idx4t6 = SVector(4, 5, 6) -const idx1t6 = SVector(1, 2, 3, 4, 5, 6) - - ############## # RTN | LVLH # ############## @@ -452,6 +435,4 @@ function sECEFtoECI(epc::Epoch, x::AbstractVector{<:Real}) end return x_eci -end - -end +end \ No newline at end of file diff --git a/src/sgp_models.jl b/src/sgp_models.jl index d46c212..e68d2cb 100644 --- a/src/sgp_models.jl +++ b/src/sgp_models.jl @@ -1,15 +1,3 @@ -__precompile__(true) -module SGPModels - -# Imports -using Printf -using LinearAlgebra - -using SatelliteDynamics.Constants: RAD2DEG, DEG2RAD, SECONDS_IN_DAY, OMEGA_EARTH -using SatelliteDynamics.Time: Epoch -using SatelliteDynamics.Attitude: Rz -using SatelliteDynamics.ReferenceSystems: sECEFtoECI - ######################## # Two Line Element Set # ######################## @@ -181,7 +169,7 @@ end ################## - +export tle_checksum """ Compute Two-Line Element checksum for a given line string. @@ -2463,7 +2451,4 @@ function eci(tle::TLE, epc::Epoch) s = ecef(tle, epc) return sECEFtoECI(epc, s) -end - - -end # Module \ No newline at end of file +end \ No newline at end of file diff --git a/src/simulation/integrators.jl b/src/simulation/integrators.jl index 1de84a0..35a031f 100644 --- a/src/simulation/integrators.jl +++ b/src/simulation/integrators.jl @@ -1,11 +1,4 @@ -__precompile__(true) -module Integrators - -# Imports -using SatelliteDynamics.Time: Epoch - # Exports - export RK4, istep ####### @@ -125,6 +118,4 @@ function istep(rk4::RK4, epc::Union{Real,Epoch}, dt::Real, x::Array{<:Real, 1}, phiu = phi + (dt/6.0)*(phik1 + 2.0*phik2 + 2.0*phik3 + phik4) return xu, phiu -end - -end # Module \ No newline at end of file +end \ No newline at end of file diff --git a/src/simulation/propagators.jl b/src/simulation/propagators.jl index 74df9a1..2c839c2 100644 --- a/src/simulation/propagators.jl +++ b/src/simulation/propagators.jl @@ -1,15 +1,3 @@ -__precompile__(true) -module Propagators - -# Julia Imports -using LinearAlgebra: diagm -using SatelliteDynamics.Time: Epoch -using SatelliteDynamics.Coordinates: sECEFtoGEOD -using SatelliteDynamics.ReferenceSystems -using SatelliteDynamics.OrbitDynamics -using SatelliteDynamics.EarthEnvironment.NRLMSISE00: density_nrlmsise00 -using SatelliteDynamics.Simulation.Integrators: RK4, istep - ################### # Dynamics Models # ################### @@ -293,6 +281,4 @@ Used to reinitialize the state transition matrix value to identity """ function reinit!(state::EarthInertialState) state.phi = diagm(0 => ones(Float64, length(state.x))) -end - -end # Module \ No newline at end of file +end \ No newline at end of file diff --git a/src/simulation/simulation.jl b/src/simulation/simulation.jl index 64527b8..207cdc7 100644 --- a/src/simulation/simulation.jl +++ b/src/simulation/simulation.jl @@ -1,13 +1,3 @@ -__precompile__(true) -module Simulation - -using Reexport - # Simulation submodules include("integrators.jl") -include("propagators.jl") - -@reexport using SatelliteDynamics.Simulation.Integrators -@reexport using SatelliteDynamics.Simulation.Propagators - -end # Simulation Module \ No newline at end of file +include("propagators.jl") \ No newline at end of file diff --git a/src/time.jl b/src/time.jl index 339bd70..1dc375c 100644 --- a/src/time.jl +++ b/src/time.jl @@ -1,11 +1,3 @@ -__precompile__(true) -module Time - -using Printf -using SOFA -using SatelliteDynamics.Constants -using SatelliteDynamics.Universe: UT1_UTC - ############# # Constants # ############# @@ -74,7 +66,7 @@ Returns: function caldate_to_mjd(year::Integer, month::Integer, day::Integer, hour::Integer=0, minute::Integer=0, second::Real=0.0, nanoseconds::Real=0.0) status, jd, fd = iauDtf2d("TAI", year, month, day, hour, minute, second + nanoseconds/1.0e9) - mjd = (jd - Constants.MJD_ZERO) + fd + mjd = (jd - MJD_ZERO) + fd return mjd end @@ -96,7 +88,7 @@ Returns: - `nanoseconds::Float64`: Nanoseconds """ function mjd_to_caldate(mjd::Real) - status, iy, im, id, ihmsf = iauD2dtf("TAI", 9, Constants.MJD_ZERO, mjd) + status, iy, im, id, ihmsf = iauD2dtf("TAI", 9, MJD_ZERO, mjd) return iy, im, id, ihmsf[1], ihmsf[2], ihmsf[3], ihmsf[4]/1.0e9 end @@ -172,7 +164,7 @@ Assumes all days are counted using a uniform 86400.0 seconds over the time span. Arguments: - `t::Real`: Elapsed seconds since the `day_epoch`. -- `day_epoch::Real`: Day number of the epoch. Common values are `SatelliteDynamics.Constants.MJD_ZERO` (to get the Julian Day number) or `SatelliteDynamics.Constants.MJD2000` (to get Modified Julian Days if reckoning time from January 1, 2000 0H) +- `day_epoch::Real`: Day number of the epoch. Common values are `SatelliteDynamics.MJD_ZERO` (to get the Julian Day number) or `SatelliteDynamics.MJD2000` (to get Modified Julian Days if reckoning time from January 1, 2000 0H) Returns: - `days::Float`: Number of elapsed days in the time scale. @@ -504,7 +496,7 @@ Returns: function mjd(epc::Epoch; tsys::String=epc.tsys) offset = time_system_offset(epc, "TAI", tsys) - return (epc.days + (epc.seconds + epc.nanoseconds/1.0e9 + offset)/86400.0) - Constants.MJD_ZERO + return (epc.days + (epc.seconds + epc.nanoseconds/1.0e9 + offset)/86400.0) - MJD_ZERO end @@ -528,7 +520,7 @@ function day_of_year(epc::Epoch; tsys::String=epc.tsys) # Compute MJD of current day offset = time_system_offset(epc, "TAI", tsys) - mjd = (epc.days + (epc.seconds + epc.nanoseconds/1.0e9 + offset)/86400.0) - Constants.MJD_ZERO + mjd = (epc.days + (epc.seconds + epc.nanoseconds/1.0e9 + offset)/86400.0) - MJD_ZERO # Get day of year is the difference doy = mjd - mjd0 + 1.0 @@ -682,7 +674,7 @@ function time_system_offset(jd, fd, tsys_src::String, tsys_dest::String) offset += dutc elseif tsys_src == "UT1" # Convert UT1 -> UTC - offset -= UT1_UTC((jd - Constants.MJD_ZERO) + fd) + offset -= UT1_UTC((jd - MJD_ZERO) + fd) # Convert UTC -> TAI status, iy, im, id, ihmsf = iauD2dtf("UTC", 6, jd, fd + offset) # Returns TAI-UTC @@ -735,7 +727,7 @@ function time_system_offset(jd, fd, tsys_src::String, tsys_dest::String) offset -= dutc # Convert UTC to UT1 - offset += UT1_UTC(u1 + u2 + offset/86400.0 - Constants.MJD_ZERO) + offset += UT1_UTC(u1 + u2 + offset/86400.0 - MJD_ZERO) elseif tsys_dest == "TAI" # Do nothing in this case end @@ -747,6 +739,4 @@ function time_system_offset(epc::Epoch, tsys_src::String, tsys_dest::String) jd = epc.days fd = (epc.seconds + epc.nanoseconds/1.0e9)/86400.0 return time_system_offset(jd, fd, tsys_src, tsys_dest) -end - -end # Time \ No newline at end of file +end \ No newline at end of file diff --git a/src/universe.jl b/src/universe.jl index 2948f25..f8b9b3b 100644 --- a/src/universe.jl +++ b/src/universe.jl @@ -1,18 +1,3 @@ -__precompile__(true) -module Universe - -################# -# Julia Imports # -################# - -using Dates - -################### -# Package Imports # -################### - -using SatelliteDynamics.Constants - ############### # Remote Data # ############### @@ -443,6 +428,4 @@ export GRAV_COEF function GRAV_COEF(i::Int, j::Int) # Offset into matrix to deal with julia indexing return GRAVITY_MODEL.data[i+1, j+1] -end - -end # End Module \ No newline at end of file +end \ No newline at end of file diff --git a/test/earth_environment/test_nrlmsise00.jl b/test/earth_environment/test_nrlmsise00.jl index 1e84cfe..c305c2e 100644 --- a/test/earth_environment/test_nrlmsise00.jl +++ b/test/earth_environment/test_nrlmsise00.jl @@ -1,9 +1,8 @@ let - using SatelliteDynamics.EarthEnvironment.NRLMSISE00: NRLMSISE_Input, NRLMSISE_Output, NRLMSISE_Flags, gtd7! # Test core NRLMSISE - Test cases match Daniel Brodo's C implementation - input = NRLMSISE_Input[NRLMSISE_Input() for i in 1:17] - output = NRLMSISE_Output[NRLMSISE_Output() for i in 1:17] - flags = NRLMSISE_Flags() + input = SatelliteDynamics.NRLMSISE_Input[SatelliteDynamics.NRLMSISE_Input() for i in 1:17] + output = SatelliteDynamics.NRLMSISE_Output[SatelliteDynamics.NRLMSISE_Output() for i in 1:17] + flags = SatelliteDynamics.NRLMSISE_Flags() # Set input values aph = ones(Float64, 7).*100.0 @@ -46,16 +45,16 @@ let input[17].ap_array = aph # Run model - gtd7!(input[1], flags, output[1]) + SatelliteDynamics.gtd7!(input[1], flags, output[1]) # Evalute 1 to 15 for i in 1:15 - gtd7!(input[i], flags, output[i]) + SatelliteDynamics.gtd7!(input[i], flags, output[i]) end # Evaluate 16 and 17 for i in 16:17 - gtd7!(input[i], flags, output[i]) + SatelliteDynamics.gtd7!(input[i], flags, output[i]) end # Test Case 1 diff --git a/test/runtests.jl b/test/runtests.jl index 77d53d5..dd7de72 100644 --- a/test/runtests.jl +++ b/test/runtests.jl @@ -7,8 +7,6 @@ using Printf # Package under test using SatelliteDynamics -using SatelliteDynamics.EarthEnvironment -using SatelliteDynamics.Simulation # Set logging level global_logger(SimpleLogger(stderr, Logging.Debug)) @@ -74,18 +72,18 @@ end end # Earth Environment - @time @testset "SatelliteDynamics.EarthEnvironment.NRLMSISE00" begin + @time @testset "SatelliteDynamics.NRLMSISE00" begin include(joinpath(testdir, "earth_environment/", "test_spaceweather.jl")) end - @time @testset "SatelliteDynamics.EarthEnvironment.NRLMSISE00" begin + @time @testset "SatelliteDynamics.NRLMSISE00" begin include(joinpath(testdir, "earth_environment/", "test_nrlmsise00.jl")) end # Simulation Tools - @time @testset "SatelliteDynamics.Simulation.Integrators" begin + @time @testset "SatelliteDynamics.Integrators" begin include(joinpath(testdir, "simulation/", "test_integrators.jl")) end - @time @testset "SatelliteDynamics.Simulation.Propagators" begin + @time @testset "SatelliteDynamics.Propagators" begin include(joinpath(testdir, "simulation/", "test_propagators.jl")) end end \ No newline at end of file diff --git a/test/simulation/test_integrators.jl b/test/simulation/test_integrators.jl index 0de158e..618e05a 100644 --- a/test/simulation/test_integrators.jl +++ b/test/simulation/test_integrators.jl @@ -76,9 +76,6 @@ let end let - # Import varmat - using SatelliteDynamics.Simulation.Integrators: varmat - # Initialize integrator rk4 = RK4(point_earth) diff --git a/test/test_sgp_models.jl b/test/test_sgp_models.jl index 77f103b..d66ad9c 100644 --- a/test/test_sgp_models.jl +++ b/test/test_sgp_models.jl @@ -3,8 +3,8 @@ let line1 = "1 00005U 58002B 00179.78495062 .00000023 00000-0 28098-4 0 4753" line2 = "2 00005 34.2682 348.7242 1859667 331.7664 19.3264 10.82419157413667" - csum1 = SGPModels.tle_checksum(line1[1:end-1]) - csum2 = SGPModels.tle_checksum(line2[1:end-1]) + csum1 = tle_checksum(line1[1:end-1]) + csum2 = tle_checksum(line2[1:end-1]) @test csum1 == parse(Int, line1[end]) @test csum2 == parse(Int, line2[end]) diff --git a/test/test_time.jl b/test/test_time.jl index bb6b73f..2a4c766 100644 --- a/test/test_time.jl +++ b/test/test_time.jl @@ -47,13 +47,13 @@ let end let - @test SatelliteDynamics.Time.valid_time_system("GPS") == true - @test SatelliteDynamics.Time.valid_time_system("TAI") == true - @test SatelliteDynamics.Time.valid_time_system("TT") == true - @test SatelliteDynamics.Time.valid_time_system("UTC") == true - @test SatelliteDynamics.Time.valid_time_system("UT1") == true + @test SatelliteDynamics.valid_time_system("GPS") == true + @test SatelliteDynamics.valid_time_system("TAI") == true + @test SatelliteDynamics.valid_time_system("TT") == true + @test SatelliteDynamics.valid_time_system("UTC") == true + @test SatelliteDynamics.valid_time_system("UT1") == true - @test SatelliteDynamics.Time.valid_time_system("BLAH") == false + @test SatelliteDynamics.valid_time_system("BLAH") == false end let