Setup.jl/src/autoload_data.jl

259 lines
16 KiB
Julia
Raw Blame History

This file contains ambiguous Unicode characters

This file contains Unicode characters that might be confused with other characters. If you think that this is intentional, you can safely ignore this warning. Use the Escape button to reveal them.

foreach(add_autoloads!, [
PkgAutoloads(
:(Base.Threads),
exported = Bindings(
macros = ["@spawn", "@threads"],
callables = [
:Atomic, :Event, :SpinLock, :Threads, :atomic_add!,
:atomic_and!, :atomic_cas!, :atomic_fence, :atomic_max!,
:atomic_min!, :atomic_nand!, :atomic_or!, :atomic_sub!,
:atomic_xchg!, :atomic_xor!, :nthreadpools, :nthreads,
:threadid, :threadpool])),
PkgAutoloads(:Base64, exported = Bindings(callables = [
:Base64DecodePipe, :Base64EncodePipe, :base64decode, :base64encode,
:stringmime])),
PkgAutoloads(:BaseDirs),
PkgAutoloads(
:BenchmarkTools,
exported = Bindings(macros = [
"@ballocated", "@belapsed", "@benchmark", "@benchmarkable",
"@benchmarkset", "@bprofile", "@btime", "@case", "@tagged"])),
PkgAutoloads(:CRC32c, exported = Bindings(callables = [:crc32c])),
PkgAutoloads(:CSV),
PkgAutoloads(:Cthulhu, exported = Bindings(
macros = ["@decend", "@decend_code_typed", "@decend_code_warntype"],
callables = [:ascend, :descend, :descend_code_typed, :descend_code_warntype])),
PkgAutoloads(
:DataFrames,
exported = Bindings(callables = [
:AbstractDataFrame, :All, :AsTable, :Between, :ByRow, :Cols,
:DataFrame, :DataFrameRow, :DataFrames, :GroupedDataFrame,
:InvertedIndex, :InvertedIndices, :Missing, :MissingException,
:Missings, :Not, :PrettyTables, :SubDataFrame, :Tables, :aggregate,
:allcombinations, :allowmissing, :allowmissing!, :antijoin, :by,
:coalesce, :colmetadata, :colmetadata!, :colmetadatakeys,
:columnindex, :combine, :completecases, :crossjoin, :delete!,
:deletecolmetadata!, :deletemetadata!, :disallowmissing,
:disallowmissing!, :dropmissing, :dropmissing!, :emptycolmetadata!,
:emptymetadata!, :emptymissing, :fillcombinations, :flatten,
:groupby, :groupcols, :groupindices, :innerjoin, :insertcols,
:insertcols!, :ismissing, :leftjoin, :leftjoin!, :levels, :mapcols,
:mapcols!, :metadata, :metadata!, :metadatakeys, :missing,
:missings, :ncol, :nonmissingtype, :nonunique, :nrow, :order,
:outerjoin, :passmissing, :proprow, :rename, :rename!, :repeat!,
:rightjoin, :rownumber, :select, :select!, :semijoin, :skipmissings,
:subset, :subset!, :transform, :transform!, :unique!, :unstack,
:valuecols])),
PkgAutoloads(
:DataToolkit,
exported = Bindings(
macros = ["@d_str", "@data_cmd", "@import"],
callables = [:DataSet, :DataToolkit, :dataset, :loadcollection!])),
PkgAutoloads(
:Dates,
exported = Bindings(
macros = ["@dateformat_str"],
callables = [
:Apr, :April, :Aug, :August, :Date, :DateFormat, :DatePeriod,
:DateTime, :Dates, :Day, :Dec, :December, :Feb, :February, :Fri,
:Friday, :Hour, :ISODateFormat, :ISODateTimeFormat,
:ISOTimeFormat, :Jan, :January, :Jul, :July, :Jun, :June, :Mar,
:March, :May, :Microsecond, :Millisecond, :Minute, :Mon,
:Monday, :Month, :Nanosecond, :Nov, :November, :Oct, :October,
:Period, :Quarter, :RFC1123Format, :Sat, :Saturday, :Second,
:Sep, :September, :Sun, :Sunday, :Thu, :Thursday, :Time,
:TimePeriod, :TimeType, :TimeZone, :Tue, :Tuesday, :UTC, :Wed,
:Wednesday, :Week, :Year, :adjust, :canonicalize,
:datetime2julian, :datetime2rata, :datetime2unix, :day,
:dayabbr, :dayname, :dayofmonth, :dayofquarter, :dayofweek,
:dayofweekofmonth, :dayofyear, :daysinmonth, :daysinyear,
:daysofweekinmonth, :firstdayofmonth, :firstdayofquarter,
:firstdayofweek, :firstdayofyear, :hour, :isleapyear,
:julian2datetime, :lastdayofmonth, :lastdayofquarter,
:lastdayofweek, :lastdayofyear, :microsecond, :millisecond,
:minute, :month, :monthabbr, :monthday, :monthname, :nanosecond,
:now, :quarterofyear, :rata2datetime, :second, :today, :tofirst,
:tolast, :tonext, :toprev, :unix2datetime, :week, :year,
:yearmonth, :yearmonthday])),
PkgAutoloads(:Debugger, exported = Bindings(macros = ["@enter", "@run"])),
PkgAutoloads(
:Distributed,
exported = Bindings(
macros = ["@distributed", "@everywhere", "@fetch", "@fetchfrom", "@spawnat"],
callables = [
:AbstractWorkerPool, :CachingPool, :ClusterManager, :Future,
:ProcessExitedException, :RemoteChannel, :RemoteException,
:WorkerConfig, :WorkerPool, :addprocs, :channel_from_id,
:check_same_host, :clear!, :cluster_cookie,
:default_worker_pool, :init_worker, :interrupt, :launch,
:manage, :myid, :nprocs, :nworkers, :pmap, :process_messages,
:procs, :remote, :remote_do, :remotecall, :remotecall_fetch,
:remotecall_wait, :remoteref_id, :rmprocs, :start_worker,
:worker_id_from_socket, :workers])),
PkgAutoloads(
:Distributions,
exported = Bindings(callables = [
:AbstractMixtureModel, :AbstractMvNormal, :Arcsine,
:ArrayLikeVariate, :Bernoulli, :BernoulliLogit, :Beta,
:BetaBinomial, :BetaPrime, :Binomial, :Biweight, :Categorical,
:Cauchy, :Chernoff, :Chi, :Chisq, :CholeskyVariate, :Continuous,
:ContinuousDistribution, :ContinuousMatrixDistribution,
:ContinuousMultivariateDistribution,
:ContinuousUnivariateDistribution, :Cosine, :DiagNormal,
:DiagNormalCanon, :Dirac, :Dirichlet, :DirichletMultinomial,
:Discrete, :DiscreteDistribution, :DiscreteMatrixDistribution,
:DiscreteMultivariateDistribution, :DiscreteNonParametric,
:DiscreteUniform, :DiscreteUnivariateDistribution, :Distribution,
:DoubleExponential, :EdgeworthMean, :EdgeworthSum, :EdgeworthZ,
:Epanechnikov, :Erlang, :Estimator, :Exponential, :FDist,
:FisherNoncentralHypergeometric, :Frechet, :FullNormal,
:FullNormalCanon, :Gamma, :GeneralizedExtremeValue,
:GeneralizedPareto, :Geometric, :Gumbel, :Hypergeometric,
:InverseGamma, :InverseGaussian, :InverseWishart, :IsoNormal,
:IsoNormalCanon, :JohnsonSU, :JointOrderStatistics, :KSDist,
:KSOneSided, :Kolmogorov, :Kumaraswamy, :LKJ, :LKJCholesky,
:Laplace, :Levy, :Lindley, :LocationScale, :LogNormal, :LogUniform,
:Logistic, :LogitNormal, :MLEstimator, :MatrixBeta,
:MatrixDistribution, :MatrixFDist, :MatrixNormal, :MatrixReshaped,
:MatrixTDist, :Matrixvariate, :MixtureModel, :Multinomial,
:Multivariate, :MultivariateDistribution, :MultivariateMixture,
:MultivariateNormal, :MvLogNormal, :MvNormal, :MvNormalCanon,
:MvNormalKnownCov, :MvTDist, :NegativeBinomial,
:NonMatrixDistribution, :NoncentralBeta, :NoncentralChisq,
:NoncentralF, :NoncentralHypergeometric, :NoncentralT, :Normal,
:NormalCanon, :NormalInverseGaussian, :OrderStatistic,
:PGeneralizedGaussian, :Pareto, :Poisson, :PoissonBinomial,
:Product, :QQPair, :Rayleigh, :RealInterval, :Rician, :Sampleable,
:Semicircle, :Skellam, :SkewNormal, :SkewedExponentialPower,
:Soliton, :StudentizedRange, :SufficientStats, :SymTriangularDist,
:TDist, :TriangularDist, :Triweight, :Truncated, :TruncatedNormal,
:Uniform, :Univariate, :UnivariateDistribution, :UnivariateGMM,
:UnivariateMixture, :ValueSupport, :VariateForm, :VonMises,
:VonMisesFisher, :WalleniusNoncentralHypergeometric, :Weibull,
:Wishart, :ZeroMeanDiagNormal, :ZeroMeanDiagNormalCanon,
:ZeroMeanFullNormal, :ZeroMeanFullNormalCanon, :ZeroMeanIsoNormal,
:ZeroMeanIsoNormalCanon, :canonform, :ccdf, :cdf, :censored, :cf,
:cgf, :circvar, :component, :components, :componentwise_logpdf,
:componentwise_pdf, :concentration, :convolve, :cquantile,
:estimate, :expected_logdet, :failprob, :fit_mle, :gradlogpdf,
:hasfinitesupport, :insupport, :invcov, :invlogccdf, :invlogcdf,
:invscale, :isbounded, :isleptokurtic, :islowerbounded,
:ismesokurtic, :isplatykurtic, :isprobvec, :isupperbounded,
:location, :location!, :logccdf, :logcdf, :logdetcov, :logdiffcdf,
:logpdf, :logpdf!, :meandir, :meanform, :meanlogx, :mgf,
:ncategories, :ncomponents, :nsamples, :ntrials, :partype, :pdf,
:pdfsquaredL2norm, :probs, :probval, :product_distribution,
:qqbuild, :rate, :sampler, :scale, :scale!, :shape, :sqmahal,
:sqmahal!, :stdlogx, :succprob, :suffstats, :support, :truncated,
:varlogx])),
PkgAutoloads(
:Downloads,
exported = Bindings(callables = [
:Downloader, :RequestError, :Response, :download, :request])),
PkgAutoloads(:JET, exported = Bindings(
macros = ["@report_call", "@report_opt", "@test_call", "@test_opt"],
callables = [:AnyFrameModule, :LastFrameModule, :report_call,
:report_file, :report_opt, :report_package, :report_text,
:test_call, :test_file, :test_opt, :test_package,
:test_text, :watch_file])),
PkgAutoloads(:JSON3),
PkgAutoloads(
:LinearAlgebra,
exported = Bindings(callables = [
:Adjoint, :BLAS, :Bidiagonal, :BunchKaufman, :Cholesky,
:CholeskyPivoted, :ColumnNorm, :Diagonal, :Eigen, :Factorization,
:GeneralizedEigen, :GeneralizedSVD, :GeneralizedSchur, :Hermitian,
:Hessenberg, :I, :LAPACK, :LAPACKException, :LDLt, :LQ, :LU,
:LinearAlgebra, :LowerTriangular, :NoPivot, :PosDefException, :QR,
:QRPivoted, :RankDeficientException, :RowMaximum, :RowNonZero, :SVD,
:Schur, :SingularException, :SymTridiagonal, :Symmetric, :Transpose,
:Tridiagonal, :UniformScaling, :UnitLowerTriangular,
:UnitUpperTriangular, :UpperHessenberg, :UpperTriangular,
:ZeroPivotException, :adjoint!, :axpby!, :axpy!, :bunchkaufman,
:bunchkaufman!, :cholesky, :cholesky!, :cond, :condskeel,
:copy_transpose!, :copyto!, :cross, :det, :diag, :diagind, :diagm,
:dot, :eigen, :eigen!, :eigmax, :eigmin, :eigvals, :eigvals!,
:eigvecs, :factorize, :givens, :hessenberg, :hessenberg!, :isdiag,
:ishermitian, :isposdef, :isposdef!, :issuccess, :issymmetric,
:istril, :istriu, :kron, :kron!, :ldiv!, :ldlt, :ldlt!, :lmul!,
:logabsdet, :logdet, :lowrankdowndate, :lowrankdowndate!,
:lowrankupdate, :lowrankupdate!, :lq, :lq!, :lu, :lu!, :lyap, :mul!,
:norm, :normalize, :normalize!, :nullspace, :opnorm, :ordschur,
:ordschur!, :pinv, :qr, :qr!, :rank, :rdiv!, :reflect!, :rmul!,
:rotate!, :schur, :schur!, :svd, :svd!, :svdvals, :svdvals!,
:sylvester, :tr, :transpose, :transpose!, :tril, :tril!, :triu,
:triu!, :×, :⋅])),
PkgAutoloads(:Markdown, exported =
Bindings(macros = ["@doc_str", "@md_str"],
callables = [:html, :latex])),
PkgAutoloads(:Mmap, exported = Bindings(callables = [:mmap])),
PkgAutoloads(:Org, exported = Bindings(
macros = ["@org_str"],
callables = [:Org, :OrgDoc, :org, :parsetree, :tableofcontents, :term])),
PkgAutoloads(:Pkg, exported = Bindings(macros = ["@pkg_str"])),
PkgAutoloads(:Printf, exported = Bindings(macros = ["@printf"])),
PkgAutoloads(:Random, exported = Bindings(callables = [
:AbstractRNG, :MersenneTwister, :Random, :RandomDevice, :TaskLocalRNG,
:Xoshiro, :bitrand, :rand!, :randcycle, :randcycle!, :randexp,
:randexp!, :randn!, :randperm, :randperm!, :randstring, :randsubseq,
:randsubseq!, :shuffle, :shuffle!])),
PkgAutoloads(:REPL, exported = Bindings(callables =
[:AbstractREPL, :BasicREPL, :LineEditREPL, :StreamREPL])),
PkgAutoloads(:SHA, exported = Bindings(callables =
[:HMAC_CTX, :SHA1_CTX, :SHA224_CTX, :SHA256_CTX, :SHA2_224_CTX,
:SHA2_256_CTX, :SHA2_384_CTX, :SHA2_512_CTX, :SHA384_CTX, :SHA3_224_CTX,
:SHA3_256_CTX, :SHA3_384_CTX, :SHA3_512_CTX, :SHA512_CTX, :digest!,
:hmac_sha1, :hmac_sha224, :hmac_sha256, :hmac_sha2_224, :hmac_sha2_256,
:hmac_sha2_384, :hmac_sha2_512, :hmac_sha384, :hmac_sha3_224,
:hmac_sha3_256, :hmac_sha3_384, :hmac_sha3_512, :hmac_sha512, :sha1,
:sha224, :sha256, :sha2_224, :sha2_256, :sha2_384, :sha2_512, :sha384,
:sha3_224, :sha3_256, :sha3_384, :sha3_512, :sha512, :update!])),
PkgAutoloads(:Serialization, exported = Bindings(callables = [
:AbstractSerializer, :Serializer, :deserialize, :serialize])),
PkgAutoloads(
:Statistics,
exported = Bindings(callables = [
:cor, :cov, :mean, :mean!, :median, :median!, :middle, :quantile,
:quantile!, :std, :stdm, :var, :varm])),
PkgAutoloads(
:StatsBase,
exported = Bindings(callables = [
:AbstractDataTransform, :AbstractHistogram, :AbstractWeights,
:AnalyticWeights, :CoefTable, :ConvergenceException,
:CovarianceEstimator, :CronbachAlpha, :ECDF, :FrequencyWeights,
:Histogram, :L1dist, :L2dist, :Linfdist, :ProbabilityWeights,
:SimpleCovariance, :UnitRangeTransform, :UnitWeights, :Weights,
:ZScoreTransform, :addcounts!, :autocor, :autocor!, :autocov,
:autocov!, :aweights, :competerank, :cor2cov, :corkendall,
:corspearman, :counteq, :countmap, :countne, :counts, :cov2cor,
:cronbachalpha, :crosscor, :crosscor!, :crosscov, :crosscov!,
:crossentropy, :cumulant, :denserank, :ecdf, :entropy, :eweights,
:fweights, :genmean, :genvar, :geomean, :gkldiv, :harmmean,
:indexmap, :indicatormat, :inverse_rle, :iqr, :kldivergence,
:kurtosis, :levelsmap, :mad, :mad!, :maxad, :mean_and_cov,
:mean_and_std, :mean_and_var, :meanad, :midpoints, :mode,
:model_response, :modes, :moment, :msd, :norepeats, :nquantile,
:ordinalrank, :pacf, :pacf!, :partialcor, :percentile,
:percentilerank, :proportionmap, :proportions, :psnr, :pweights,
:quantilerank, :renyientropy, :rle, :rmsd, :sample, :sample!,
:samplepair, :scattermat, :scattermat_zm, :scattermatm, :sem,
:skewness, :span, :sqL2dist, :standardize, :summarystats, :tiedrank,
:totalvar, :trim, :trim!, :trimvar, :uweights, :variation, :winsor,
:winsor!, :wmedian, :wquantile, :wsample, :wsample!, :wsum, :wsum!,
:zscore, :zscore!])),
PkgAutoloads(:TOML),
PkgAutoloads(:Tar),
PkgAutoloads(:Test, exported =
Bindings(macros = ["@inferred", "@test", "@test_broken",
"@test_deprecated", "@test_logs", "@test_nowarn",
"@test_skip", "@test_throws", "@test_warn",
"@testset"],
callables = [:GenericArray, :GenericDict, :GenericOrder,
:GenericSet, :GenericString, :LogRecord,
:TestLogger, :TestSetException,
:detect_ambiguities, :detect_unbound_args])),
PkgAutoloads(:UUIDs, exported = Bindings(callables = [
:uuid1, :uuid4, :uuid5, :uuid_version])),
PkgAutoloads(:WhyNotEqual, exported = Bindings(callables = [:whynot])),
])