_            _    _        _         _
      /\ \         /\ \ /\ \     /\_\      / /\
      \_\ \       /  \ \\ \ \   / / /     / /  \
      /\__ \     / /\ \ \\ \ \_/ / /     / / /\ \__
     / /_ \ \   / / /\ \ \\ \___/ /     / / /\ \___\
    / / /\ \ \ / / /  \ \_\\ \ \_/      \ \ \ \/___/
   / / /  \/_// / /   / / / \ \ \        \ \ \
  / / /      / / /   / / /   \ \ \   _    \ \ \
 / / /      / / /___/ / /     \ \ \ /_/\__/ / /
/_/ /      / / /____\/ /       \ \_\\ \/___/ /
\_\/       \/_________/         \/_/ \_____\/

Enter the query into the form above. You can look for specific version of a package by using @ symbol like this: gcc@10.

API method:

GET /api/packages?search=hello&page=1&limit=20

where search is your query, page is a page number and limit is a number of items on a single page. Pagination information (such as a number of pages and etc) is returned in response headers.

If you'd like to join our channel webring send a patch to ~whereiseveryone/toys@lists.sr.ht adding your channel as an entry in channels.scm.


r-simnph 0.5.8
Propagated dependencies: r-tidyr@1.3.1 r-tibble@3.3.0 r-survival@3.8-3 r-stringr@1.6.0 r-simdesign@2.21 r-rlang@1.1.6 r-purrr@1.2.0 r-nphrct@0.1.1 r-nph@2.1 r-minipch@0.4.0 r-dplyr@1.1.4 r-car@3.1-3
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://simnph.github.io/SimNPH/
Licenses: FSDG-compatible
Synopsis: Simulate Non-Proportional Hazards
Description:

This package provides a toolkit for simulation studies concerning time-to-event endpoints with non-proportional hazards. SimNPH encompasses functions for simulating time-to-event data in various scenarios, simulating different trial designs like fixed-followup, event-driven, and group sequential designs. The package provides functions to calculate the true values of common summary statistics for the implemented scenarios and offers common analysis methods for time-to-event data. Helper functions for running simulations with the SimDesign package and for aggregating and presenting the results are also included. Results of the conducted simulation study are available in the paper: "A Comparison of Statistical Methods for Time-To-Event Analyses in Randomized Controlled Trials Under Non-Proportional Hazards", Klinglmüller et al. (2025) <doi:10.1002/sim.70019>.

r-spatialacc 0.1-5
Propagated dependencies: r-sp@2.2-0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://stamatisgeoai.eu/
Licenses: GPL 2+
Synopsis: Spatial Accessibility Measures
Description:

This package provides a set of spatial accessibility measures from a set of locations (demand) to another set of locations (supply). It aims, among others, to support research on spatial accessibility to health care facilities. Includes the locations and some characteristics of major public hospitals in Greece.

r-sixtyfour 0.2.0
Propagated dependencies: r-withr@3.0.2 r-uuid@1.2-1 r-tidyr@1.3.1 r-tibble@3.3.0 r-s3fs@0.1.7 r-rlang@1.1.6 r-purrr@1.2.0 r-paws-common@0.8.7 r-paws@0.9.0 r-memoise@2.0.1 r-jsonlite@2.0.0 r-ipaddress@1.0.3 r-glue@1.8.0 r-fs@1.6.6 r-dplyr@1.1.4 r-curl@7.0.0 r-clipr@0.8.0 r-cli@3.6.5
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/getwilds/sixtyfour
Licenses: Expat
Synopsis: Humane Interface to Amazon Web Services
Description:

An opinionated interface to Amazon Web Services <https://aws.amazon.com>, with functions for interacting with IAM (Identity and Access Management), S3 (Simple Storage Service), RDS (Relational Data Service), Redshift, and Billing. Lower level functions ('aws_ prefix) are for do it yourself workflows, while higher level functions ('six_ prefix) automate common tasks.

r-spmoran 0.3.3
Propagated dependencies: r-vegan@2.7-2 r-spdep@1.4-1 r-sf@1.0-23 r-rcolorbrewer@1.1-3 r-rarpack@0.11-0 r-matrix@1.7-4 r-ggplot2@4.0.1 r-foreach@1.5.2 r-fnn@1.1.4.1 r-fields@17.1 r-doparallel@1.0.17
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/dmuraka/spmoran
Licenses: GPL 2+
Synopsis: Fast Spatial and Spatio-Temporal Regression using Moran Eigenvectors
Description:

This package provides a collection of functions for estimating spatial and spatio-temporal regression models. Moran eigenvectors are used as spatial basis functions to efficiently approximate spatially dependent Gaussian processes (i.e., random effects eigenvector spatial filtering; see Murakami and Griffith 2015 <doi: 10.1007/s10109-015-0213-7>). The implemented models include linear regression with residual spatial dependence, spatially/spatio-temporally varying coefficient models (Murakami et al., 2017, 2024; <doi:10.1016/j.spasta.2016.12.001>,<doi:10.48550/arXiv.2410.07229>), spatially filtered unconditional quantile regression (Murakami and Seya, 2019 <doi:10.1002/env.2556>), Gaussian and non-Gaussian spatial mixed models through compositionally-warping (Murakami et al. 2021, <doi:10.1016/j.spasta.2021.100520>).

r-symmetry 0.2.3
Propagated dependencies: r-rdpack@2.6.4 r-rcpparmadillo@15.2.2-1 r-rcpp@1.1.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=symmetry
Licenses: Expat
Synopsis: Testing for Symmetry of Data and Model Residuals
Description:

Implementations of a large number of tests for symmetry and their bootstrap variants, which can be used for testing the symmetry of random samples around a known or unknown mean. Functions are also there for testing the symmetry of model residuals around zero. Currently, the supported models are linear models and generalized autoregressive conditional heteroskedasticity (GARCH) models (fitted with the fGarch package). All tests are implemented using the Rcpp package which ensures great performance of the code.

r-socratadata 0.1.1
Dependencies: xz@5.4.5
Propagated dependencies: r-tibble@3.3.0 r-sf@1.0-23 r-rlang@1.1.6 r-httr2@1.2.1 r-cli@3.6.5
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://ryanzomorrodi.github.io/socratadata/
Licenses: GPL 3+
Synopsis: Explore Socrata Data with Ease
Description:

This package provides an interface to search, read, query, and retrieve metadata for datasets hosted on Socrata open data portals. Supports all Socrata data types, including spatial data returned as sf objects.

r-sorptionanalysis 0.1.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=SorptionAnalysis
Licenses: GPL 2
Synopsis: Static Adsorption Experiment Plotting and Analysis
Description:

This package provides tools to efficiently analyze and visualize laboratory data from aqueous static adsorption experiments. The package provides functions to plot Langmuir, Freundlich, and Temkin isotherms and functions to determine the statistical conformity of data points to the Langmuir, Freundlich, and Temkin adsorption models through statistical characterization of the isothermic least squares regressions lines. Scientific Reference: Dada, A.O, Olalekan, A., Olatunya, A. (2012) <doi:10.9790/5736-0313845>.

r-sautomata 0.1.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=SAutomata
Licenses: GPL 3+
Synopsis: Inference and Learning in Stochastic Automata
Description:

Machine learning provides algorithms that can learn from data and make inferences or predictions. Stochastic automata is a class of input/output devices which can model components. This work provides implementation an inference algorithm for stochastic automata which is similar to the Viterbi algorithm. Moreover, we specify a learning algorithm using the expectation-maximization technique and provide a more efficient implementation of the Baum-Welch algorithm for stochastic automata. This work is based on Inference and learning in stochastic automata was by Karl-Heinz Zimmermann(2017) <doi:10.12732/ijpam.v115i3.15>.

r-swaprinc 1.0.1
Propagated dependencies: r-tidyselect@1.2.1 r-rlang@1.1.6 r-magrittr@2.0.4 r-lme4@1.1-37 r-gifi@1.0-0 r-dplyr@1.1.4 r-broom-mixed@0.2.9.6 r-broom@1.0.10
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/mncube/swaprinc
Licenses: Expat
Synopsis: Swap Principal Components into Regression Models
Description:

Obtaining accurate and stable estimates of regression coefficients can be challenging when the suggested statistical model has issues related to multicollinearity, convergence, or overfitting. One solution is to use principal component analysis (PCA) results in the regression, as discussed in Chan and Park (2005) <doi:10.1080/01446190500039812>. The swaprinc() package streamlines comparisons between a raw regression model with the full set of raw independent variables and a principal component regression model where principal components are estimated on a subset of the independent variables, then swapped into the regression model in place of those variables. The swaprinc() function compares one raw regression model to one principal component regression model, while the compswap() function compares one raw regression model to many principal component regression models. Package functions include parameters to center, scale, and undo centering and scaling, as described by Harvey and Hansen (2022) <https://cran.r-project.org/package=LearnPCA/vignettes/Vig_03_Step_By_Step_PCA.pdf>. Additionally, the package supports using Gifi methods to extract principal components from categorical variables, as outlined by Rossiter (2021) <https://www.css.cornell.edu/faculty/dgr2/_static/files/R_html/NonlinearPCA.html#2_Package>.

r-slidecna 0.1.0
Propagated dependencies: r-tidyselect@1.2.1 r-tibble@3.3.0 r-stringr@1.6.0 r-seurat@5.3.1 r-scales@1.4.0 r-reshape2@1.4.5 r-pheatmap@1.0.13 r-mltools@0.3.5 r-magrittr@2.0.4 r-ggplot2@4.0.1 r-futile-logger@1.4.3 r-factoextra@1.0.7 r-dplyr@1.1.4 r-dendextend@1.19.1 r-data-table@1.17.8 r-cluster@2.1.8.1
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=SlideCNA
Licenses: GPL 3+
Synopsis: Calls Copy Number Alterations from Slide-Seq Data
Description:

This takes spatial single-cell-type RNA-seq data (specifically designed for Slide-seq v2) that calls copy number alterations (CNAs) using pseudo-spatial binning, clusters cellular units (e.g. beads) based on CNA profile, and visualizes spatial CNA patterns. Documentation about SlideCNA is included in the the pre-print by Zhang et al. (2022, <doi:10.1101/2022.11.25.517982>). The package enrichR (>= 3.0), conditionally used to annotate SlideCNA-determined clusters with gene ontology terms, can be installed at <https://github.com/wjawaid/enrichR> or with install_github("wjawaid/enrichR").

r-stringx 0.2.9
Propagated dependencies: r-stringi@1.8.7
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://stringx.gagolewski.com/
Licenses: GPL 2+
Synopsis: Replacements for Base String Functions Powered by 'stringi'
Description:

English is the native language for only 5% of the World population. Also, only 17% of us can understand this text. Moreover, the Latin alphabet is the main one for merely 36% of the total. The early computer era, now a very long time ago, was dominated by the US. Due to the proliferation of the internet, smartphones, social media, and other technologies and communication platforms, this is no longer the case. This package replaces base R string functions (such as grep(), tolower(), sprintf(), and strptime()) with ones that fully support the Unicode standards related to natural language and date-time processing. It also fixes some long-standing inconsistencies, and introduces some new, useful features. Thanks to ICU (International Components for Unicode) and stringi', they are fast, reliable, and portable across different platforms.

r-spup 1.4-0
Propagated dependencies: r-whisker@0.4.1 r-raster@3.6-32 r-purrr@1.2.0 r-mvtnorm@1.3-3 r-magrittr@2.0.4 r-gstat@2.1-4
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=spup
Licenses: GPL 3+
Synopsis: Spatial Uncertainty Propagation Analysis
Description:

Uncertainty propagation analysis in spatial environmental modelling following methodology described in Heuvelink et al. (2007) <doi:10.1080/13658810601063951> and Brown and Heuvelink (2007) <doi:10.1016/j.cageo.2006.06.015>. The package provides functions for examining the uncertainty propagation starting from input data and model parameters, via the environmental model onto model outputs. The functions include uncertainty model specification, stochastic simulation and propagation of uncertainty using Monte Carlo (MC) techniques. Uncertain variables are described by probability distributions. Both numerical and categorical data types are handled. Spatial auto-correlation within an attribute and cross-correlation between attributes is accommodated for. The MC realizations may be used as input to the environmental models called from R, or externally.

r-spsurvey 5.6.0
Propagated dependencies: r-units@1.0-0 r-survey@4.4-8 r-sf@1.0-23 r-sampling@2.11 r-mass@7.3-65 r-lme4@1.1-37 r-deldir@2.0-4 r-crossdes@1.1-2 r-boot@1.3-32
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://usepa.github.io/spsurvey/
Licenses: GPL 3+
Synopsis: Spatial Sampling Design and Analysis
Description:

This package provides a design-based approach to statistical inference, with a focus on spatial data. Spatially balanced samples are selected using the Generalized Random Tessellation Stratified (GRTS) algorithm. The GRTS algorithm can be applied to finite resources (point geometries) and infinite resources (linear / linestring and areal / polygon geometries) and flexibly accommodates a diverse set of sampling design features, including stratification, unequal inclusion probabilities, proportional (to size) inclusion probabilities, legacy (historical) sites, a minimum distance between sites, and two options for replacement sites (reverse hierarchical order and nearest neighbor). Data are analyzed using a wide range of analysis functions that perform categorical variable analysis, continuous variable analysis, attributable risk analysis, risk difference analysis, relative risk analysis, change analysis, and trend analysis. spsurvey can also be used to summarize objects, visualize objects, select samples that are not spatially balanced, select panel samples, measure the amount of spatial balance in a sample, adjust design weights, and more. For additional details, see Dumelle et al. (2023) <doi:10.18637/jss.v105.i03>.

r-sbtools 1.4.1
Propagated dependencies: r-mime@0.13 r-keyring@1.4.1 r-jsonlite@2.0.0 r-httr@1.4.7 r-curl@7.0.0 r-cli@3.6.5
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/DOI-USGS/sbtools
Licenses: CC0
Synopsis: USGS ScienceBase Tools
Description:

This package provides tools for interacting with U.S. Geological Survey ScienceBase <https://www.sciencebase.gov> interfaces. ScienceBase is a data cataloging and collaborative data management platform. Functions included for querying ScienceBase, and creating and fetching datasets.

r-sapfluxnetr 0.1.5
Propagated dependencies: r-tidyr@1.3.1 r-tibble@3.3.0 r-stringr@1.6.0 r-rlang@1.1.6 r-purrr@1.2.0 r-magrittr@2.0.4 r-lubridate@1.9.4 r-glue@1.8.0 r-ggplot2@4.0.1 r-furrr@0.3.1 r-dplyr@1.1.4 r-assertthat@0.2.1
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/sapfluxnet/sapfluxnetr
Licenses: Expat
Synopsis: Working with 'Sapfluxnet' Project Data
Description:

Access, modify, aggregate and plot data from the Sapfluxnet project, the first global database of sap flow measurements.

r-scina 1.2.0
Propagated dependencies: r-mass@7.3-65 r-gplots@3.2.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=SCINA
Licenses: GPL 2
Synopsis: Semi-Supervised Category Identification and Assignment Tool
Description:

An automatic cell type detection and assignment algorithm for single cell RNA-Seq and Cytof/FACS data. SCINA is capable of assigning cell type identities to a pool of cells profiled by scRNA-Seq or Cytof/FACS data with prior knowledge of markers, such as genes and protein symbols that are highly or lowly expressed in each category. See Zhang Z, et al (2019) <doi:10.3390/genes10070531> for more details.

r-snsmart 0.2.4
Propagated dependencies: r-truncdist@1.0-2 r-tidyr@1.3.1 r-rjags@4-17 r-pracma@2.4.6 r-hdinterval@0.2.4 r-geepack@1.3.13 r-envstats@3.1.0 r-cubature@2.1.4-1 r-condmvnorm@2025.1 r-bayestestr@0.17.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/sidiwang/snSMART
Licenses: GPL 2+
Synopsis: Small N Sequential Multiple Assignment Randomized Trial Methods
Description:

Consolidated data simulation, sample size calculation and analysis functions for several snSMART (small sample sequential, multiple assignment, randomized trial) designs under one library. See Wei, B., Braun, T.M., Tamura, R.N. and Kidwell, K.M. "A Bayesian analysis of small n sequential multiple assignment randomized trials (snSMARTs)." (2018) Statistics in medicine, 37(26), pp.3723-3732 <doi:10.1002/sim.7900>.

r-stlarima 0.1.0
Propagated dependencies: r-forecast@8.24.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=stlARIMA
Licenses: GPL 3
Synopsis: STL Decomposition and ARIMA Hybrid Forecasting Model
Description:

Univariate time series forecasting with STL decomposition based auto regressive integrated moving average (ARIMA) hybrid model. For method details see Xiong T, Li C, Bao Y (2018). <doi:10.1016/j.neucom.2017.11.053>.

r-selectboost-gamlss 0.2.2
Propagated dependencies: r-selectboost@2.3.0 r-rlang@1.1.6 r-rcpparmadillo@15.2.2-1 r-rcpp@1.1.0 r-gamlss@5.5-0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://fbertran.github.io/SelectBoost.gamlss/
Licenses: GPL 3
Synopsis: Stability-Selection via Correlated Resampling for 'GAMLSS' Models
Description:

Extends the SelectBoost approach to Generalized Additive Models for Location, Scale and Shape (GAMLSS). Implements bootstrap stability-selection across parameter-specific formulas (mu, sigma, nu, tau) via gamlss::stepGAIC(). Includes optional standardization of predictors and helper functions for corrected AIC calculation. More details can be found in Bertrand and Maumy (2024) <https://hal.science/hal-05352041> that highlights correlation-aware resampling to improve variable selection for GAMLSS and quantile regression when predictors are numerous and highly correlated.

r-simic 0.1.0
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/jayarasan/simIC
Licenses: Expat
Synopsis: Simulate and Analyze Interval- and Mixed-Censored Survival Data
Description:

This package provides tools to simulate and analyze survival data with interval-, left-, right-, and uncensored observations under common parametric distributions, including "Weibull", "Exponential", "Log-Normal", "Log-Logistic", "Gamma", "Gompertz", "Normal", "Logistic", and "EMV". The package supports both direct maximum likelihood estimation and imputation-based methods, making it suitable for methodological research, simulation benchmarking, and teaching. A web-based companion app is also available for demonstration purposes.

r-shazam 1.3.0
Propagated dependencies: r-tidyselect@1.2.1 r-tidyr@1.3.1 r-stringi@1.8.7 r-seqinr@4.2-36 r-scales@1.4.0 r-rlang@1.1.6 r-progress@1.2.3 r-mass@7.3-65 r-lazyeval@0.2.2 r-kernsmooth@2.23-26 r-iterators@1.0.14 r-igraph@2.2.1 r-ggplot2@4.0.1 r-foreach@1.5.2 r-dplyr@1.1.4 r-doparallel@1.0.17 r-diptest@0.77-2 r-ape@5.8-1 r-alakazam@1.4.2
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: http://shazam.readthedocs.io
Licenses: AGPL 3
Synopsis: Immunoglobulin Somatic Hypermutation Analysis
Description:

This package provides a computational framework for analyzing mutations in immunoglobulin (Ig) sequences. Includes methods for Bayesian estimation of antigen-driven selection pressure, mutational load quantification, building of somatic hypermutation (SHM) models, and model-dependent distance calculations. Also includes empirically derived models of SHM for both mice and humans. Citations: Gupta and Vander Heiden, et al (2015) <doi:10.1093/bioinformatics/btv359>, Yaari, et al (2012) <doi:10.1093/nar/gks457>, Yaari, et al (2013) <doi:10.3389/fimmu.2013.00358>, Cui, et al (2016) <doi:10.4049/jimmunol.1502263>.

r-survdisc 0.1.1
Propagated dependencies: r-survival@3.8-3 r-simex@1.8 r-nlme@3.1-168 r-mvtnorm@1.3-3 r-mass@7.3-65 r-cubature@2.1.4-1
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=SurvDisc
Licenses: GPL 2
Synopsis: Discrete Time Survival and Longitudinal Data Analysis
Description:

Various functions for discrete time survival analysis and longitudinal analysis. SIMEX method for correcting for bias for errors-in-variables in a mixed effects model. Asymptotic mean and variance of different proportional hazards test statistics using different ties methods given two survival curves and censoring distributions. Score test and Wald test for regression analysis of grouped survival data. Calculation of survival curves for events defined by the response variable in a mixed effects model crossing a threshold with or without confirmation.

r-sts 1.4
Propagated dependencies: r-tm@0.7-16 r-stm@1.3.8 r-slam@0.1-55 r-rcpparmadillo@15.2.2-1 r-rcpp@1.1.0 r-mvtnorm@1.3-3 r-matrixstats@1.5.0 r-matrix@1.7-4 r-glmnet@4.1-10 r-ggplot2@4.0.1 r-foreach@1.5.2 r-doparallel@1.0.17
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://cran.r-project.org/package=sts
Licenses: Expat
Synopsis: Estimation of the Structural Topic and Sentiment-Discourse Model for Text Analysis
Description:

The Structural Topic and Sentiment-Discourse (STS) model allows researchers to estimate topic models with document-level metadata that determines both topic prevalence and sentiment-discourse. The sentiment-discourse is modeled as a document-level latent variable for each topic that modulates the word frequency within a topic. These latent topic sentiment-discourse variables are controlled by the document-level metadata. The STS model can be useful for regression analysis with text data in addition to topic modelingâ s traditional use of descriptive analysis. The method was developed in Chen and Mankad (2024) <doi:10.1287/mnsc.2022.00261>.

r-semid 0.4.2
Propagated dependencies: r-r-utils@2.13.0 r-r-oo@1.27.1 r-r-methodss3@1.8.2 r-igraph@2.2.1
Channel: guix-cran
Location: guix-cran/packages/s.scm (guix-cran packages s)
Home page: https://github.com/Lucaweihs/SEMID
Licenses: GPL 2+
Synopsis: Identifiability of Linear Structural Equation Models
Description:

This package provides routines to check identifiability or non-identifiability of linear structural equation models as described in Drton, Foygel, and Sullivant (2011) <doi:10.1214/10-AOS859>, Foygel, Draisma, and Drton (2012) <doi:10.1214/12-AOS1012>, and other works. The routines are based on the graphical representation of structural equation models.

Page: 123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459460461462463464465466467468469470471472473474475476477478479480481482483484485486487488489490491492493494495496497498499500501502503504505506507508509510511512513514515516517518519520521522523524525526527528529530531532533534535536537538539540541542543544545546547548549550551552553554555556557558559560561562563564565566567568569570571572573574575576577578579580581582583584585586587588589590591592593594595596597598599600601602603604605606607608609610611612613614615616617618619620621622623624625626627628629630631632633634635636637638639640641642643644645646647648649650651652653654655656657658659660661662663664665666667668669670671672673674675676677678679680681682683684685686687688689690691692693694695696697698699700701702703704705706707708709710711712713714715716717718719720721722723724725726727728729730731732733734735736737738739740741742743744745746747748749750751752753754755756757758759760761762763764765766767768769770771772773774775776777778779780781782783784785786787788789790791792793794795796797798799800801802803804805806807808809810811812813814815816817818819820821822823824825826827828829830831832833834835836837838839840841842843844845846847848849850851852853854855856857858859860861862863864865866867868869870871872873874875876877878879880881882883884
Total results: 21208