gseapy


Namegseapy JSON
Version 1.1.2 PyPI version JSON
download
home_pagehttps://github.com/zqfang/gseapy
SummaryGene Set Enrichment Analysis in Python
upload_time2024-02-29 20:26:18
maintainer
docs_urlNone
authorZhuoqing Fang
requires_python>=3.7
licenseMIT
keywords gene ontology go biology enrichment bioinformatics computational biology
VCS
bugtrack_url
requirements No requirements were recorded.
Travis-CI No Travis.
coveralls test coverage No coveralls.
            
GSEApy
========

GSEApy: Gene Set Enrichment Analysis in Python.
------------------------------------------------

.. image:: https://badge.fury.io/py/gseapy.svg
    :target: https://badge.fury.io/py/gseapy

.. image:: https://img.shields.io/conda/vn/bioconda/GSEApy.svg?style=plastic
    :target: http://bioconda.github.io

.. image:: https://anaconda.org/bioconda/gseapy/badges/downloads.svg   
    :target: https://anaconda.org/bioconda/gseapy

.. image:: https://github.com/zqfang/GSEApy/workflows/GSEApy/badge.svg?branch=master
    :target: https://github.com/zqfang/GSEApy/actions
    :alt: Action Status

.. image:: http://readthedocs.org/projects/gseapy/badge/?version=master
    :target: http://gseapy.readthedocs.io/en/master/?badge=master
    :alt: Documentation Status

.. image:: https://img.shields.io/badge/license-MIT-blue.svg
    :target:  https://img.shields.io/badge/license-MIT-blue.svg

.. image:: https://img.shields.io/pypi/pyversions/gseapy.svg
    :alt: PyPI - Python Version


**Release notes** : https://github.com/zqfang/GSEApy/releases

`Tutorial for scRNA-seq datasets <https://gseapy.readthedocs.io/en/latest/singlecell_example.html#>`_

`Tutorial for general usage <https://gseapy.readthedocs.io/en/latest/gseapy_example.html>`_


Citation
------------------------------------
::

    Zhuoqing Fang, Xinyuan Liu, Gary Peltz, GSEApy: a comprehensive package for performing gene set enrichment analysis in Python, 
    Bioinformatics, 2022;, btac757, https://doi.org/10.1093/bioinformatics/btac757



GSEApy is a Python/Rust implementation for **GSEA** and wrapper for **Enrichr**.
--------------------------------------------------------------------------------------------

GSEApy can be used for **RNA-seq, ChIP-seq, Microarray** data. It can be used for convenient GO enrichment and to produce **publication quality figures** in python.


GSEApy has 7 sub-commands available: ``gsea``, ``prerank``, ``ssgsea``, ``gsva``, ``replot`` ``enrichr``, ``biomart``.


:gsea:    The ``gsea`` module produces `GSEA  <http://www.broadinstitute.org/cancer/software/gsea/wiki/index.php/Main_Page>`_ results.  The input requries a txt file(FPKM, Expected Counts, TPM, et.al), a cls file, and gene_sets file in gmt format.
:prerank: The ``prerank`` module produces **Prerank tool** results.  The input expects a pre-ranked gene list dataset with correlation values, provided in .rnk format, and gene_sets file in gmt format.  ``prerank`` module is an API to `GSEA` pre-rank tools.
:ssgsea: The ``ssgsea`` module performs **single sample GSEA(ssGSEA)** analysis.  The input expects a pd.Series (indexed by gene name), or a pd.DataFrame (include ``GCT`` file) with expression values and a ``GMT`` file. For multiple sample input, ssGSEA reconigzes gct format, too. ssGSEA enrichment score for the gene set is described by `D. Barbie et al 2009 <http://www.nature.com/nature/journal/v462/n7269/abs/nature08460.html>`_.
:gsva: The ``gsva`` module performs `GSVA <https://github.com/rcastelo/GSVA>`_ method by `Hänzelmann et al <https://bmcbioinformatics.biomedcentral.com/articles/10.1186/1471-2105-14-7>`_. The input is same to ssgsea.
:replot: The ``replot`` module reproduce GSEA desktop version results.  The only input for GSEApy is the location to ``GSEA`` Desktop output results.
:enrichr: The ``enrichr`` module enable you perform gene set enrichment analysis using ``Enrichr`` API. Enrichr is open source and freely available online at: http://amp.pharm.mssm.edu/Enrichr . It runs very fast.
:biomart: The ``biomart`` module helps you convert gene ids using BioMart API.


Please use 'gseapy COMMAND -h' to see the detail description for each option of each module.


The full ``GSEA`` is far too extensive to describe here; see
`GSEA  <http://www.broadinstitute.org/cancer/software/gsea/wiki/index.php/Main_Page>`_ documentation for more information. All files' formats for GSEApy are identical to ``GSEA`` desktop version.



Why GSEApy
-----------------------------------------------------

I would like to use Pandas to explore my data, but I did not find a convenient tool to
do gene set enrichment analysis in python. So, here are my reasons:

* **Ability to run inside python interactive console without having to switch to R!!!**
* User friendly for both wet and dry lab users.
* Produce or reproduce publishable figures.
* Perform batch jobs easy.
* Easy to use in bash shell or your data analysis workflow, e.g. snakemake.


GSEApy vs GSEA(Broad) output
-----------------------------------------------
Using the same data for ``GSEAPreranked``, and ``GSEApy`` reproduce similar results.


.. image:: docs/Preank.py.vs.broad.jpg
    :width: 400


See more output here: `Example <http://gseapy.readthedocs.io/en/master/gseapy_example.html>`_


Installation
------------

| Install gseapy package from bioconda or pip.


.. code:: shell

   # if you have conda (MacOS_x86-64 and Linux only)
   $ conda install -c bioconda gseapy
   # Windows and MacOS_ARM64(M1/2-Chip)
   $ pip install gseapy


| If pip install failed, use

.. code:: shell

   # you need to install rust first to compile the code
   curl https://sh.rustup.rs -sSf | sh -s -- -y
   # export rust compiler 
   export PATH="$PATH:$HOME/.cargo/bin"
   # install
   $ pip install git+git://github.com/zqfang/gseapy.git#egg=gseapy


Dependency
--------------
* Python 3.7+

Mandatory
~~~~~~~~~

* build
    * Rust: For gseapy > 0.11.0, Rust compiler is needed
    * setuptools-rust
* run
    * Numpy >= 1.13.0
    * Scipy
    * Pandas
    * Matplotlib
    * Requests

Run GSEApy
-----------------


For command line usage:
~~~~~~~~~~~~~~~~~~~~~~~

.. code:: bash


  # An example to reproduce figures using replot module.
  $ gseapy replot -i ./Gsea.reports -o test


  # An example to run GSEA using gseapy gsea module
  $ gseapy gsea -d exptable.txt -c test.cls -g gene_sets.gmt -o test

  # An example to run Prerank using gseapy prerank module
  $ gseapy prerank -r gsea_data.rnk -g gene_sets.gmt -o test

  # An example to run ssGSEA using gseapy ssgsea module
  $ gseapy ssgsea -d expression.txt -g gene_sets.gmt -o test

  # An example to run GSVA using gseapy ssgsea module
  $ gseapy gsva -d expression.txt -g gene_sets.gmt -o test

  # An example to use enrichr api
  # see details for -g input -> ``get_library_name`` 
  $ gseapy enrichr -i gene_list.txt -g KEGG_2016 -o test



Run gseapy inside python console:
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

1. Prepare expression.txt, gene_sets.gmt and test.cls required by GSEA, you could do this

.. code:: python

    import gseapy

    # run GSEA.
    gseapy.gsea(data='expression.txt', gene_sets='gene_sets.gmt', cls='test.cls', outdir='test')

    # run prerank
    gseapy.prerank(rnk='gsea_data.rnk', gene_sets='gene_sets.gmt', outdir='test')

    # run ssGSEA
    gseapy.ssgsea(data="expression.txt", gene_sets= "gene_sets.gmt", outdir='test')

    # run GSVA
    gseapy.gsva(data="expression.txt", gene_sets= "gene_sets.gmt", outdir='test')

    # An example to reproduce figures using replot module.
    gseapy.replot(indir='./Gsea.reports', outdir='test')


2. If you prefer to use Dataframe, dict, list in interactive python console, you could do this.

see detail here: `Example <http://gseapy.readthedocs.io/en/master/gseapy_example.html>`_

.. code:: python


    # assign dataframe, and use enrichr library data set 'KEGG_2016'
    expression_dataframe = pd.DataFrame()

    sample_name = ['A','A','A','B','B','B'] # always only two group,any names you like

    # assign gene_sets parameter with enrichr library name or gmt file on your local computer.
    gseapy.gsea(data=expression_dataframe, gene_sets='KEGG_2016', cls= sample_names, outdir='test')

    # prerank tool
    gene_ranked_dataframe = pd.DataFrame()
    gseapy.prerank(rnk=gene_ranked_dataframe, gene_sets='KEGG_2016', outdir='test')

    # ssGSEA
    gseapy.ssgsea(data=expression_dataframe, gene_sets='KEGG_2016', outdir='test')

    # gsva
    gseapy.gsva(data=expression_dataframe, gene_sets='KEGG_2016', outdir='test')


3. For ``enrichr`` , you could assign a list, pd.Series, pd.DataFrame object, or a txt file (should be one gene name per row.)

.. code:: python

    # assign a list object to enrichr
    gl = ['SCARA3', 'LOC100044683', 'CMBL', 'CLIC6', 'IL13RA1', 'TACSTD2', 'DKKL1', 'CSF1',
         'SYNPO2L', 'TINAGL1', 'PTX3', 'BGN', 'HERC1', 'EFNA1', 'CIB2', 'PMP22', 'TMEM173']

    gseapy.enrichr(gene_list=gl, gene_sets='KEGG_2016', outdir='test')

    # or a txt file path.
    gseapy.enrichr(gene_list='gene_list.txt', gene_sets='KEGG_2016',
                   outdir='test', cutoff=0.05, format='png' )


GSEApy supported gene set libaries :
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

To see the full list of gseapy supported gene set libraries, please click here: `Library <http://amp.pharm.mssm.edu/Enrichr/#stats>`_

Or use ``get_library_name`` function inside python console.

.. code:: python

    #see full list of latest enrichr library names, which will pass to -g parameter:
    names = gseapy.get_library_name()

    # show top 20 entries.
    print(names[:20])


   ['Genome_Browser_PWMs',
   'TRANSFAC_and_JASPAR_PWMs',
   'ChEA_2013',
   'Drug_Perturbations_from_GEO_2014',
   'ENCODE_TF_ChIP-seq_2014',
   'BioCarta_2013',
   'Reactome_2013',
   'WikiPathways_2013',
   'Disease_Signatures_from_GEO_up_2014',
   'KEGG_2016',
   'TF-LOF_Expression_from_GEO',
   'TargetScan_microRNA',
   'PPI_Hub_Proteins',
   'GO_Molecular_Function_2015',
   'GeneSigDB',
   'Chromosome_Location',
   'Human_Gene_Atlas',
   'Mouse_Gene_Atlas',
   'GO_Cellular_Component_2015',
   'GO_Biological_Process_2015',
   'Human_Phenotype_Ontology',]



Dev 
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~

.. code:: shell


        # test rust extension only 
        cargo test --features=extension-module
        # test whole package
        python setup.py test



Bug Report
~~~~~~~~~~~~~~~~~~~~~~~~~~~

If you would like to report any bugs when use gseapy, don't hesitate to create an issue on github here.


To get help of GSEApy
------------------------------------

1. See `Frequently Asked Questions <https://gseapy.readthedocs.io/en/latest/faq.html>`_

2. Visit the document site at `Examples <https://gseapy.readthedocs.io/en/latest/gseapy_example.html>`_

3. The GSEApy discussion channel: `Q&A <https://github.com/zqfang/GSEApy/discussions>`_ 


            

Raw data

            {
    "_id": null,
    "home_page": "https://github.com/zqfang/gseapy",
    "name": "gseapy",
    "maintainer": "",
    "docs_url": null,
    "requires_python": ">=3.7",
    "maintainer_email": "",
    "keywords": "Gene Ontology,GO,Biology,Enrichment,Bioinformatics,Computational Biology",
    "author": "Zhuoqing Fang",
    "author_email": "fzq518@gmail.com",
    "download_url": "https://files.pythonhosted.org/packages/bc/54/4e09f7d74d0d1778b081fff8853a3ca6d03a951032424691be6d2df6fbea/gseapy-1.1.2.tar.gz",
    "platform": null,
    "description": "\nGSEApy\n========\n\nGSEApy: Gene Set Enrichment Analysis in Python.\n------------------------------------------------\n\n.. image:: https://badge.fury.io/py/gseapy.svg\n    :target: https://badge.fury.io/py/gseapy\n\n.. image:: https://img.shields.io/conda/vn/bioconda/GSEApy.svg?style=plastic\n    :target: http://bioconda.github.io\n\n.. image:: https://anaconda.org/bioconda/gseapy/badges/downloads.svg   \n    :target: https://anaconda.org/bioconda/gseapy\n\n.. image:: https://github.com/zqfang/GSEApy/workflows/GSEApy/badge.svg?branch=master\n    :target: https://github.com/zqfang/GSEApy/actions\n    :alt: Action Status\n\n.. image:: http://readthedocs.org/projects/gseapy/badge/?version=master\n    :target: http://gseapy.readthedocs.io/en/master/?badge=master\n    :alt: Documentation Status\n\n.. image:: https://img.shields.io/badge/license-MIT-blue.svg\n    :target:  https://img.shields.io/badge/license-MIT-blue.svg\n\n.. image:: https://img.shields.io/pypi/pyversions/gseapy.svg\n    :alt: PyPI - Python Version\n\n\n**Release notes** : https://github.com/zqfang/GSEApy/releases\n\n`Tutorial for scRNA-seq datasets <https://gseapy.readthedocs.io/en/latest/singlecell_example.html#>`_\n\n`Tutorial for general usage <https://gseapy.readthedocs.io/en/latest/gseapy_example.html>`_\n\n\nCitation\n------------------------------------\n::\n\n    Zhuoqing Fang, Xinyuan Liu, Gary Peltz, GSEApy: a comprehensive package for performing gene set enrichment analysis in Python, \n    Bioinformatics, 2022;, btac757, https://doi.org/10.1093/bioinformatics/btac757\n\n\n\nGSEApy is a Python/Rust implementation for **GSEA** and wrapper for **Enrichr**.\n--------------------------------------------------------------------------------------------\n\nGSEApy can be used for **RNA-seq, ChIP-seq, Microarray** data. It can be used for convenient GO enrichment and to produce **publication quality figures** in python.\n\n\nGSEApy has 7 sub-commands available: ``gsea``, ``prerank``, ``ssgsea``, ``gsva``, ``replot`` ``enrichr``, ``biomart``.\n\n\n:gsea:    The ``gsea`` module produces `GSEA  <http://www.broadinstitute.org/cancer/software/gsea/wiki/index.php/Main_Page>`_ results.  The input requries a txt file(FPKM, Expected Counts, TPM, et.al), a cls file, and gene_sets file in gmt format.\n:prerank: The ``prerank`` module produces **Prerank tool** results.  The input expects a pre-ranked gene list dataset with correlation values, provided in .rnk format, and gene_sets file in gmt format.  ``prerank`` module is an API to `GSEA` pre-rank tools.\n:ssgsea: The ``ssgsea`` module performs **single sample GSEA(ssGSEA)** analysis.  The input expects a pd.Series (indexed by gene name), or a pd.DataFrame (include ``GCT`` file) with expression values and a ``GMT`` file. For multiple sample input, ssGSEA reconigzes gct format, too. ssGSEA enrichment score for the gene set is described by `D. Barbie et al 2009 <http://www.nature.com/nature/journal/v462/n7269/abs/nature08460.html>`_.\n:gsva: The ``gsva`` module performs `GSVA <https://github.com/rcastelo/GSVA>`_ method by `H\u00e4nzelmann et al <https://bmcbioinformatics.biomedcentral.com/articles/10.1186/1471-2105-14-7>`_. The input is same to ssgsea.\n:replot: The ``replot`` module reproduce GSEA desktop version results.  The only input for GSEApy is the location to ``GSEA`` Desktop output results.\n:enrichr: The ``enrichr`` module enable you perform gene set enrichment analysis using ``Enrichr`` API. Enrichr is open source and freely available online at: http://amp.pharm.mssm.edu/Enrichr . It runs very fast.\n:biomart: The ``biomart`` module helps you convert gene ids using BioMart API.\n\n\nPlease use 'gseapy COMMAND -h' to see the detail description for each option of each module.\n\n\nThe full ``GSEA`` is far too extensive to describe here; see\n`GSEA  <http://www.broadinstitute.org/cancer/software/gsea/wiki/index.php/Main_Page>`_ documentation for more information. All files' formats for GSEApy are identical to ``GSEA`` desktop version.\n\n\n\nWhy GSEApy\n-----------------------------------------------------\n\nI would like to use Pandas to explore my data, but I did not find a convenient tool to\ndo gene set enrichment analysis in python. So, here are my reasons:\n\n* **Ability to run inside python interactive console without having to switch to R!!!**\n* User friendly for both wet and dry lab users.\n* Produce or reproduce publishable figures.\n* Perform batch jobs easy.\n* Easy to use in bash shell or your data analysis workflow, e.g. snakemake.\n\n\nGSEApy vs GSEA(Broad) output\n-----------------------------------------------\nUsing the same data for ``GSEAPreranked``, and ``GSEApy`` reproduce similar results.\n\n\n.. image:: docs/Preank.py.vs.broad.jpg\n    :width: 400\n\n\nSee more output here: `Example <http://gseapy.readthedocs.io/en/master/gseapy_example.html>`_\n\n\nInstallation\n------------\n\n| Install gseapy package from bioconda or pip.\n\n\n.. code:: shell\n\n   # if you have conda (MacOS_x86-64 and Linux only)\n   $ conda install -c bioconda gseapy\n   # Windows and MacOS_ARM64(M1/2-Chip)\n   $ pip install gseapy\n\n\n| If pip install failed, use\n\n.. code:: shell\n\n   # you need to install rust first to compile the code\n   curl https://sh.rustup.rs -sSf | sh -s -- -y\n   # export rust compiler \n   export PATH=\"$PATH:$HOME/.cargo/bin\"\n   # install\n   $ pip install git+git://github.com/zqfang/gseapy.git#egg=gseapy\n\n\nDependency\n--------------\n* Python 3.7+\n\nMandatory\n~~~~~~~~~\n\n* build\n    * Rust: For gseapy > 0.11.0, Rust compiler is needed\n    * setuptools-rust\n* run\n    * Numpy >= 1.13.0\n    * Scipy\n    * Pandas\n    * Matplotlib\n    * Requests\n\nRun GSEApy\n-----------------\n\n\nFor command line usage:\n~~~~~~~~~~~~~~~~~~~~~~~\n\n.. code:: bash\n\n\n  # An example to reproduce figures using replot module.\n  $ gseapy replot -i ./Gsea.reports -o test\n\n\n  # An example to run GSEA using gseapy gsea module\n  $ gseapy gsea -d exptable.txt -c test.cls -g gene_sets.gmt -o test\n\n  # An example to run Prerank using gseapy prerank module\n  $ gseapy prerank -r gsea_data.rnk -g gene_sets.gmt -o test\n\n  # An example to run ssGSEA using gseapy ssgsea module\n  $ gseapy ssgsea -d expression.txt -g gene_sets.gmt -o test\n\n  # An example to run GSVA using gseapy ssgsea module\n  $ gseapy gsva -d expression.txt -g gene_sets.gmt -o test\n\n  # An example to use enrichr api\n  # see details for -g input -> ``get_library_name`` \n  $ gseapy enrichr -i gene_list.txt -g KEGG_2016 -o test\n\n\n\nRun gseapy inside python console:\n~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~\n\n1. Prepare expression.txt, gene_sets.gmt and test.cls required by GSEA, you could do this\n\n.. code:: python\n\n    import gseapy\n\n    # run GSEA.\n    gseapy.gsea(data='expression.txt', gene_sets='gene_sets.gmt', cls='test.cls', outdir='test')\n\n    # run prerank\n    gseapy.prerank(rnk='gsea_data.rnk', gene_sets='gene_sets.gmt', outdir='test')\n\n    # run ssGSEA\n    gseapy.ssgsea(data=\"expression.txt\", gene_sets= \"gene_sets.gmt\", outdir='test')\n\n    # run GSVA\n    gseapy.gsva(data=\"expression.txt\", gene_sets= \"gene_sets.gmt\", outdir='test')\n\n    # An example to reproduce figures using replot module.\n    gseapy.replot(indir='./Gsea.reports', outdir='test')\n\n\n2. If you prefer to use Dataframe, dict, list in interactive python console, you could do this.\n\nsee detail here: `Example <http://gseapy.readthedocs.io/en/master/gseapy_example.html>`_\n\n.. code:: python\n\n\n    # assign dataframe, and use enrichr library data set 'KEGG_2016'\n    expression_dataframe = pd.DataFrame()\n\n    sample_name = ['A','A','A','B','B','B'] # always only two group,any names you like\n\n    # assign gene_sets parameter with enrichr library name or gmt file on your local computer.\n    gseapy.gsea(data=expression_dataframe, gene_sets='KEGG_2016', cls= sample_names, outdir='test')\n\n    # prerank tool\n    gene_ranked_dataframe = pd.DataFrame()\n    gseapy.prerank(rnk=gene_ranked_dataframe, gene_sets='KEGG_2016', outdir='test')\n\n    # ssGSEA\n    gseapy.ssgsea(data=expression_dataframe, gene_sets='KEGG_2016', outdir='test')\n\n    # gsva\n    gseapy.gsva(data=expression_dataframe, gene_sets='KEGG_2016', outdir='test')\n\n\n3. For ``enrichr`` , you could assign a list, pd.Series, pd.DataFrame object, or a txt file (should be one gene name per row.)\n\n.. code:: python\n\n    # assign a list object to enrichr\n    gl = ['SCARA3', 'LOC100044683', 'CMBL', 'CLIC6', 'IL13RA1', 'TACSTD2', 'DKKL1', 'CSF1',\n         'SYNPO2L', 'TINAGL1', 'PTX3', 'BGN', 'HERC1', 'EFNA1', 'CIB2', 'PMP22', 'TMEM173']\n\n    gseapy.enrichr(gene_list=gl, gene_sets='KEGG_2016', outdir='test')\n\n    # or a txt file path.\n    gseapy.enrichr(gene_list='gene_list.txt', gene_sets='KEGG_2016',\n                   outdir='test', cutoff=0.05, format='png' )\n\n\nGSEApy supported gene set libaries :\n~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~\n\nTo see the full list of gseapy supported gene set libraries, please click here: `Library <http://amp.pharm.mssm.edu/Enrichr/#stats>`_\n\nOr use ``get_library_name`` function inside python console.\n\n.. code:: python\n\n    #see full list of latest enrichr library names, which will pass to -g parameter:\n    names = gseapy.get_library_name()\n\n    # show top 20 entries.\n    print(names[:20])\n\n\n   ['Genome_Browser_PWMs',\n   'TRANSFAC_and_JASPAR_PWMs',\n   'ChEA_2013',\n   'Drug_Perturbations_from_GEO_2014',\n   'ENCODE_TF_ChIP-seq_2014',\n   'BioCarta_2013',\n   'Reactome_2013',\n   'WikiPathways_2013',\n   'Disease_Signatures_from_GEO_up_2014',\n   'KEGG_2016',\n   'TF-LOF_Expression_from_GEO',\n   'TargetScan_microRNA',\n   'PPI_Hub_Proteins',\n   'GO_Molecular_Function_2015',\n   'GeneSigDB',\n   'Chromosome_Location',\n   'Human_Gene_Atlas',\n   'Mouse_Gene_Atlas',\n   'GO_Cellular_Component_2015',\n   'GO_Biological_Process_2015',\n   'Human_Phenotype_Ontology',]\n\n\n\nDev \n~~~~~~~~~~~~~~~~~~~~~~~~~~~~~\n\n.. code:: shell\n\n\n        # test rust extension only \n        cargo test --features=extension-module\n        # test whole package\n        python setup.py test\n\n\n\nBug Report\n~~~~~~~~~~~~~~~~~~~~~~~~~~~\n\nIf you would like to report any bugs when use gseapy, don't hesitate to create an issue on github here.\n\n\nTo get help of GSEApy\n------------------------------------\n\n1. See `Frequently Asked Questions <https://gseapy.readthedocs.io/en/latest/faq.html>`_\n\n2. Visit the document site at `Examples <https://gseapy.readthedocs.io/en/latest/gseapy_example.html>`_\n\n3. The GSEApy discussion channel: `Q&A <https://github.com/zqfang/GSEApy/discussions>`_ \n\n",
    "bugtrack_url": null,
    "license": "MIT",
    "summary": "Gene Set Enrichment Analysis in Python",
    "version": "1.1.2",
    "project_urls": {
        "Documentation": "https://gseapy.readthedocs.io/en/latest/",
        "Download": "https://github.com/zqfang/gseapy",
        "Homepage": "https://github.com/zqfang/gseapy",
        "Source": "https://github.com/zqfang/GSEApy",
        "Tracker": "https://github.com/zqfang/GSEApy/issues"
    },
    "split_keywords": [
        "gene ontology",
        "go",
        "biology",
        "enrichment",
        "bioinformatics",
        "computational biology"
    ],
    "urls": [
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "9dcd154aa1bac730e7c07dd462050316bc3c7f73319bb7b541d48ba3c4f88112",
                "md5": "a1cc0029cd11285b15f11e430c0981de",
                "sha256": "939d6eb6341130815e822308f9d20fb6a09f6054dc5364c7517fb3eecd414f55"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-macosx_10_9_universal2.whl",
            "has_sig": false,
            "md5_digest": "a1cc0029cd11285b15f11e430c0981de",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 923172,
            "upload_time": "2024-02-29T20:33:35",
            "upload_time_iso_8601": "2024-02-29T20:33:35.977587Z",
            "url": "https://files.pythonhosted.org/packages/9d/cd/154aa1bac730e7c07dd462050316bc3c7f73319bb7b541d48ba3c4f88112/gseapy-1.1.2-cp310-cp310-macosx_10_9_universal2.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "cba3a74228306d5e1fceb15d7362d4ffe9e68913b8377dd59b5e4bc799de75cd",
                "md5": "6bb2ee2950ceba93ebf6a6d2f8c067c3",
                "sha256": "d296fe51718204d039a85dd9dc9f01df769f04922999201ee50c9ef411a03f2c"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-macosx_10_9_x86_64.whl",
            "has_sig": false,
            "md5_digest": "6bb2ee2950ceba93ebf6a6d2f8c067c3",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 510518,
            "upload_time": "2024-02-29T20:32:02",
            "upload_time_iso_8601": "2024-02-29T20:32:02.224524Z",
            "url": "https://files.pythonhosted.org/packages/cb/a3/a74228306d5e1fceb15d7362d4ffe9e68913b8377dd59b5e4bc799de75cd/gseapy-1.1.2-cp310-cp310-macosx_10_9_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "97c2f607575b1046b5619209e5675b5bca7cddc48df1c930be6055266b8b8bbe",
                "md5": "d5468ed49b649a0bc2266833f2b4db11",
                "sha256": "48081260e246f7704beca869642b28c55cbbdbfef41ee817352ed3670880a96c"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-macosx_11_0_arm64.whl",
            "has_sig": false,
            "md5_digest": "d5468ed49b649a0bc2266833f2b4db11",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 498792,
            "upload_time": "2024-02-29T20:33:37",
            "upload_time_iso_8601": "2024-02-29T20:33:37.385383Z",
            "url": "https://files.pythonhosted.org/packages/97/c2/f607575b1046b5619209e5675b5bca7cddc48df1c930be6055266b8b8bbe/gseapy-1.1.2-cp310-cp310-macosx_11_0_arm64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "7acef997620315743ffa3665144de7161968104e3c59cf60cfc5997cc0295eb5",
                "md5": "0c39af81e09b9eaaa7dcbd712530853c",
                "sha256": "5403d062f7c068ec24ac2ff9da6e6d7259a2f824690c891677223285b1b55c03"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "has_sig": false,
            "md5_digest": "0c39af81e09b9eaaa7dcbd712530853c",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 1339537,
            "upload_time": "2024-02-29T20:31:52",
            "upload_time_iso_8601": "2024-02-29T20:31:52.295460Z",
            "url": "https://files.pythonhosted.org/packages/7a/ce/f997620315743ffa3665144de7161968104e3c59cf60cfc5997cc0295eb5/gseapy-1.1.2-cp310-cp310-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "bc39347a4116949c9b7b79ad66cda77f81ac3518bea850bd1f4221e28def9725",
                "md5": "c90f2c629dbac6e707620fe9918ec89f",
                "sha256": "12bf0f01daca84559f7817b9195fc0507e7cda50091dde3400a1b856118ab4f9"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "has_sig": false,
            "md5_digest": "c90f2c629dbac6e707620fe9918ec89f",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 1309325,
            "upload_time": "2024-02-29T20:31:53",
            "upload_time_iso_8601": "2024-02-29T20:31:53.996830Z",
            "url": "https://files.pythonhosted.org/packages/bc/39/347a4116949c9b7b79ad66cda77f81ac3518bea850bd1f4221e28def9725/gseapy-1.1.2-cp310-cp310-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "4a6b70d50b9191adb15b0de87ac4da21542d009d0e97493f1d66f778d55a6d3a",
                "md5": "4ac14d51eed904c4ca2541d2c52c129c",
                "sha256": "a310e71e9ddfb647afd741a3308418fd3dfd5324b3db2ff8e64b41f84ac9e2f6"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-win32.whl",
            "has_sig": false,
            "md5_digest": "4ac14d51eed904c4ca2541d2c52c129c",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 357382,
            "upload_time": "2024-02-29T20:31:34",
            "upload_time_iso_8601": "2024-02-29T20:31:34.108299Z",
            "url": "https://files.pythonhosted.org/packages/4a/6b/70d50b9191adb15b0de87ac4da21542d009d0e97493f1d66f778d55a6d3a/gseapy-1.1.2-cp310-cp310-win32.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "de3131189a75097ba36df21ccec4842c649e929665d381e75f806bca06040aa3",
                "md5": "1587d878914d35bee6fcf918cc949a09",
                "sha256": "2f9e932d1dc29359cb0def7caf09152ab3a093ffeaee22dc1905905d7f3f7c00"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp310-cp310-win_amd64.whl",
            "has_sig": false,
            "md5_digest": "1587d878914d35bee6fcf918cc949a09",
            "packagetype": "bdist_wheel",
            "python_version": "cp310",
            "requires_python": ">=3.7",
            "size": 386131,
            "upload_time": "2024-02-29T20:31:21",
            "upload_time_iso_8601": "2024-02-29T20:31:21.392623Z",
            "url": "https://files.pythonhosted.org/packages/de/31/31189a75097ba36df21ccec4842c649e929665d381e75f806bca06040aa3/gseapy-1.1.2-cp310-cp310-win_amd64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "9558c86aa0ca7e1482527dfae3ba95c3ebe373cea09a1988e1712096ff834873",
                "md5": "deacd7e634ab4ef1a24e229600b85f07",
                "sha256": "de12066cb2dae77e87dcbdfaa64cb70bbfa33437499137fc6acfac7128dd44ed"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-macosx_10_9_universal2.whl",
            "has_sig": false,
            "md5_digest": "deacd7e634ab4ef1a24e229600b85f07",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 923172,
            "upload_time": "2024-02-29T20:33:57",
            "upload_time_iso_8601": "2024-02-29T20:33:57.768030Z",
            "url": "https://files.pythonhosted.org/packages/95/58/c86aa0ca7e1482527dfae3ba95c3ebe373cea09a1988e1712096ff834873/gseapy-1.1.2-cp311-cp311-macosx_10_9_universal2.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "05795080ae600f381d53c1acb3a80649e33fcae48e0e867a1e80ecebe4d138af",
                "md5": "16e7836011627074d26b760446661d4f",
                "sha256": "0ee1403c9d1c6913b1e4a0c49858c44113a60881678fdbb4ea5d862c28f9bec8"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-macosx_10_9_x86_64.whl",
            "has_sig": false,
            "md5_digest": "16e7836011627074d26b760446661d4f",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 510518,
            "upload_time": "2024-02-29T20:32:05",
            "upload_time_iso_8601": "2024-02-29T20:32:05.660153Z",
            "url": "https://files.pythonhosted.org/packages/05/79/5080ae600f381d53c1acb3a80649e33fcae48e0e867a1e80ecebe4d138af/gseapy-1.1.2-cp311-cp311-macosx_10_9_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "d2d972a5ba7172abd218d6f4043027f8d4ec61f1924e3a5474e2a17d13252794",
                "md5": "d635534042cff152a57d9a4def148f58",
                "sha256": "c2306b4749445592ea1945709f447be80099e9b0105f5e18e514bd2f8bef4ed1"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-macosx_11_0_arm64.whl",
            "has_sig": false,
            "md5_digest": "d635534042cff152a57d9a4def148f58",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 498794,
            "upload_time": "2024-02-29T20:33:59",
            "upload_time_iso_8601": "2024-02-29T20:33:59.866312Z",
            "url": "https://files.pythonhosted.org/packages/d2/d9/72a5ba7172abd218d6f4043027f8d4ec61f1924e3a5474e2a17d13252794/gseapy-1.1.2-cp311-cp311-macosx_11_0_arm64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "372bae16228fe860cfb34372da8620c66fdb713648614792454f518dfc0cd844",
                "md5": "ab754cba3dfac21d6b9a911f26779eca",
                "sha256": "a51e714ebafa09205e1e6b04532a55cc89cac8209e742f122d33efe58f99f986"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "has_sig": false,
            "md5_digest": "ab754cba3dfac21d6b9a911f26779eca",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 1339537,
            "upload_time": "2024-02-29T20:31:55",
            "upload_time_iso_8601": "2024-02-29T20:31:55.652392Z",
            "url": "https://files.pythonhosted.org/packages/37/2b/ae16228fe860cfb34372da8620c66fdb713648614792454f518dfc0cd844/gseapy-1.1.2-cp311-cp311-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "26ee2206d7f3f5e3496557b300dd246997cfa823cc6c3b459c74f033bb2d3305",
                "md5": "cf6010cf76d18f233033963ab6f2f7e6",
                "sha256": "3e996810c2420ca3866b18c0cbbee1243e2179d9ce7191096101d3b6acd8d749"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "has_sig": false,
            "md5_digest": "cf6010cf76d18f233033963ab6f2f7e6",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 1309325,
            "upload_time": "2024-02-29T20:31:57",
            "upload_time_iso_8601": "2024-02-29T20:31:57.447876Z",
            "url": "https://files.pythonhosted.org/packages/26/ee/2206d7f3f5e3496557b300dd246997cfa823cc6c3b459c74f033bb2d3305/gseapy-1.1.2-cp311-cp311-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "864cfcbcfdcd886d07927a780bfa528940b02a71740675cc13b9541fcd67bbbb",
                "md5": "c3b056a63c1fd2e5c9db6fff5b804dc4",
                "sha256": "efc234c1b520a5b9bc48614b276b25467776e5404afbe77d6c95fa30aa2f0856"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-win32.whl",
            "has_sig": false,
            "md5_digest": "c3b056a63c1fd2e5c9db6fff5b804dc4",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 357384,
            "upload_time": "2024-02-29T20:31:36",
            "upload_time_iso_8601": "2024-02-29T20:31:36.135986Z",
            "url": "https://files.pythonhosted.org/packages/86/4c/fcbcfdcd886d07927a780bfa528940b02a71740675cc13b9541fcd67bbbb/gseapy-1.1.2-cp311-cp311-win32.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "a454dc1c4b9a26db37c9c9eb7c12ec699d7be0d2cab5e0ed549f387f76b15bfc",
                "md5": "fceeddf3dae930a7b4e381991c78f54f",
                "sha256": "b115f881c8c389568209c3659e73d2a0d5c47547a5cd50aa8ae906e2481b2654"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp311-cp311-win_amd64.whl",
            "has_sig": false,
            "md5_digest": "fceeddf3dae930a7b4e381991c78f54f",
            "packagetype": "bdist_wheel",
            "python_version": "cp311",
            "requires_python": ">=3.7",
            "size": 386134,
            "upload_time": "2024-02-29T20:31:23",
            "upload_time_iso_8601": "2024-02-29T20:31:23.783460Z",
            "url": "https://files.pythonhosted.org/packages/a4/54/dc1c4b9a26db37c9c9eb7c12ec699d7be0d2cab5e0ed549f387f76b15bfc/gseapy-1.1.2-cp311-cp311-win_amd64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "a87afaa5ce6833aabac23681fe322739883f2bac52244b6689858aa1094962da",
                "md5": "0113df2255437790f6c8a73c41b6ac60",
                "sha256": "0dff17d6848e63ab5e82a353b37f853350448d5083ef381153d28d3db2847d75"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp37-cp37m-macosx_10_9_x86_64.whl",
            "has_sig": false,
            "md5_digest": "0113df2255437790f6c8a73c41b6ac60",
            "packagetype": "bdist_wheel",
            "python_version": "cp37",
            "requires_python": ">=3.7",
            "size": 509591,
            "upload_time": "2024-02-29T20:32:08",
            "upload_time_iso_8601": "2024-02-29T20:32:08.150569Z",
            "url": "https://files.pythonhosted.org/packages/a8/7a/faa5ce6833aabac23681fe322739883f2bac52244b6689858aa1094962da/gseapy-1.1.2-cp37-cp37m-macosx_10_9_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "2db5292c77e2a545d97b41a74e0be2b5390439f97bb4a3eccc815552cbb2d488",
                "md5": "00d5b6e86781210394315c6ad0e7219b",
                "sha256": "3e08242d333a87419db6f48e24d6bb8c25777834095cd8681c206e31b475c812"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp37-cp37m-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "has_sig": false,
            "md5_digest": "00d5b6e86781210394315c6ad0e7219b",
            "packagetype": "bdist_wheel",
            "python_version": "cp37",
            "requires_python": ">=3.7",
            "size": 1340174,
            "upload_time": "2024-02-29T20:31:59",
            "upload_time_iso_8601": "2024-02-29T20:31:59.839761Z",
            "url": "https://files.pythonhosted.org/packages/2d/b5/292c77e2a545d97b41a74e0be2b5390439f97bb4a3eccc815552cbb2d488/gseapy-1.1.2-cp37-cp37m-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "215398d657015fcfc2f8f4a1676c0fa25962a6d23e32a2f1b0d636896a603d56",
                "md5": "1021789801fdd5458c3ef682294fec24",
                "sha256": "42af260061651c94404efd506f9ac1a68ee3eade5f11c6cbe466cdf15092d0fa"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp37-cp37m-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "has_sig": false,
            "md5_digest": "1021789801fdd5458c3ef682294fec24",
            "packagetype": "bdist_wheel",
            "python_version": "cp37",
            "requires_python": ">=3.7",
            "size": 1308056,
            "upload_time": "2024-02-29T20:32:02",
            "upload_time_iso_8601": "2024-02-29T20:32:02.362977Z",
            "url": "https://files.pythonhosted.org/packages/21/53/98d657015fcfc2f8f4a1676c0fa25962a6d23e32a2f1b0d636896a603d56/gseapy-1.1.2-cp37-cp37m-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "cdb8a61f1af37b40bf607472807d1fe5acbfd2eccab77dbb581e480fcf6a65e3",
                "md5": "8ca623599c8a881ad15502250633cde4",
                "sha256": "3030bc0c03d9623f6627bc11db4d1be47f45e7ae5000756d80bb3ecb481ba1c6"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp37-cp37m-win32.whl",
            "has_sig": false,
            "md5_digest": "8ca623599c8a881ad15502250633cde4",
            "packagetype": "bdist_wheel",
            "python_version": "cp37",
            "requires_python": ">=3.7",
            "size": 357171,
            "upload_time": "2024-02-29T20:31:37",
            "upload_time_iso_8601": "2024-02-29T20:31:37.312838Z",
            "url": "https://files.pythonhosted.org/packages/cd/b8/a61f1af37b40bf607472807d1fe5acbfd2eccab77dbb581e480fcf6a65e3/gseapy-1.1.2-cp37-cp37m-win32.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "a9fb6aafa962522e53611c1a529d5ac726f2c811e7c705fac64de9895d14ea33",
                "md5": "4820baf2e4b2c7abd6f916038b1a2ea2",
                "sha256": "d9111ac865956cfe6ef17bbcf6a1c6da4f73e24bda30d272019bf52076bb19ae"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp37-cp37m-win_amd64.whl",
            "has_sig": false,
            "md5_digest": "4820baf2e4b2c7abd6f916038b1a2ea2",
            "packagetype": "bdist_wheel",
            "python_version": "cp37",
            "requires_python": ">=3.7",
            "size": 385858,
            "upload_time": "2024-02-29T20:31:25",
            "upload_time_iso_8601": "2024-02-29T20:31:25.322453Z",
            "url": "https://files.pythonhosted.org/packages/a9/fb/6aafa962522e53611c1a529d5ac726f2c811e7c705fac64de9895d14ea33/gseapy-1.1.2-cp37-cp37m-win_amd64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "f121240de73e02caab297fe05cd990ddb95e663986c4cf42c33d8f66b3af260d",
                "md5": "e4aa2d50f2161e88dc2a258ab884de79",
                "sha256": "61bd712693e66c3e84074899bfed7a34351f6b613eef7d4c340405a0e518578e"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp38-cp38-macosx_10_9_x86_64.whl",
            "has_sig": false,
            "md5_digest": "e4aa2d50f2161e88dc2a258ab884de79",
            "packagetype": "bdist_wheel",
            "python_version": "cp38",
            "requires_python": ">=3.7",
            "size": 509071,
            "upload_time": "2024-02-29T20:32:11",
            "upload_time_iso_8601": "2024-02-29T20:32:11.613824Z",
            "url": "https://files.pythonhosted.org/packages/f1/21/240de73e02caab297fe05cd990ddb95e663986c4cf42c33d8f66b3af260d/gseapy-1.1.2-cp38-cp38-macosx_10_9_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "9c471ac5954853b140f3b0cf58b60043574ba851d033eb0b82e53f913a3aa7d2",
                "md5": "c7249383a79d959582be250aa2552156",
                "sha256": "37cc73ea6dfbaf5c9a2274ea8ed6cae7fdc41d1590ea54c697eb0d5ea2be6396"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp38-cp38-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "has_sig": false,
            "md5_digest": "c7249383a79d959582be250aa2552156",
            "packagetype": "bdist_wheel",
            "python_version": "cp38",
            "requires_python": ">=3.7",
            "size": 1340159,
            "upload_time": "2024-02-29T20:32:03",
            "upload_time_iso_8601": "2024-02-29T20:32:03.973124Z",
            "url": "https://files.pythonhosted.org/packages/9c/47/1ac5954853b140f3b0cf58b60043574ba851d033eb0b82e53f913a3aa7d2/gseapy-1.1.2-cp38-cp38-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "443c0f5e6174b4a2e02210d3fa99eaf113a7e3578f9508b27070d76e11421baf",
                "md5": "e2672d5b177543f0b6149014016a45a1",
                "sha256": "452f56554890a1b9ab38a3288dde6feb5d5cd819b476c6cb80bf1837c977b531"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp38-cp38-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "has_sig": false,
            "md5_digest": "e2672d5b177543f0b6149014016a45a1",
            "packagetype": "bdist_wheel",
            "python_version": "cp38",
            "requires_python": ">=3.7",
            "size": 1308071,
            "upload_time": "2024-02-29T20:32:06",
            "upload_time_iso_8601": "2024-02-29T20:32:06.817188Z",
            "url": "https://files.pythonhosted.org/packages/44/3c/0f5e6174b4a2e02210d3fa99eaf113a7e3578f9508b27070d76e11421baf/gseapy-1.1.2-cp38-cp38-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "afd295541f772c619612a78d07e89a1d975bf75f19aee5dd203095bf8ae39f9f",
                "md5": "d54f282431a4138721c6808ebb181b33",
                "sha256": "1060f75369a0d5c67b3aac3b7dad7af79572251e92276fd5fda3a160c6a74bb9"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp38-cp38-win32.whl",
            "has_sig": false,
            "md5_digest": "d54f282431a4138721c6808ebb181b33",
            "packagetype": "bdist_wheel",
            "python_version": "cp38",
            "requires_python": ">=3.7",
            "size": 357179,
            "upload_time": "2024-02-29T20:31:38",
            "upload_time_iso_8601": "2024-02-29T20:31:38.682689Z",
            "url": "https://files.pythonhosted.org/packages/af/d2/95541f772c619612a78d07e89a1d975bf75f19aee5dd203095bf8ae39f9f/gseapy-1.1.2-cp38-cp38-win32.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "e495773ed62213fc89b1e5f9df126d8e3a99110690c29397ad7da7a1e56978ae",
                "md5": "b7df6ede9535499b4c5fdbb984fd0bec",
                "sha256": "49a178d5df6cd47d59d8b8450f25804b1ecae3489abe00ecd5e5a57d2ca877dd"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp38-cp38-win_amd64.whl",
            "has_sig": false,
            "md5_digest": "b7df6ede9535499b4c5fdbb984fd0bec",
            "packagetype": "bdist_wheel",
            "python_version": "cp38",
            "requires_python": ">=3.7",
            "size": 385853,
            "upload_time": "2024-02-29T20:31:27",
            "upload_time_iso_8601": "2024-02-29T20:31:27.423504Z",
            "url": "https://files.pythonhosted.org/packages/e4/95/773ed62213fc89b1e5f9df126d8e3a99110690c29397ad7da7a1e56978ae/gseapy-1.1.2-cp38-cp38-win_amd64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "13ee1e02a179dda98bfc6055cc917ad8cb6717b4a477d29efe24f4dbf20d745e",
                "md5": "ec07fdc46bde2b932e340058d7532b65",
                "sha256": "7702bbfdea67fc2b8271b2f3d5e7ecf88fd5fd3f25e6175248c5313844bb16d7"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp39-cp39-macosx_10_9_x86_64.whl",
            "has_sig": false,
            "md5_digest": "ec07fdc46bde2b932e340058d7532b65",
            "packagetype": "bdist_wheel",
            "python_version": "cp39",
            "requires_python": ">=3.7",
            "size": 510708,
            "upload_time": "2024-02-29T20:32:14",
            "upload_time_iso_8601": "2024-02-29T20:32:14.637112Z",
            "url": "https://files.pythonhosted.org/packages/13/ee/1e02a179dda98bfc6055cc917ad8cb6717b4a477d29efe24f4dbf20d745e/gseapy-1.1.2-cp39-cp39-macosx_10_9_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "0758119fe542589cd8404ff55d430e95e75f660fb5a93fcde01aaa3f1db3ea34",
                "md5": "b481364921de1864d6e0a63cd6e43e23",
                "sha256": "07e7b269308fee110c59f6d17cd08601b74cb4a4da3b699e82f19e573a3532b4"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp39-cp39-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "has_sig": false,
            "md5_digest": "b481364921de1864d6e0a63cd6e43e23",
            "packagetype": "bdist_wheel",
            "python_version": "cp39",
            "requires_python": ">=3.7",
            "size": 1340069,
            "upload_time": "2024-02-29T20:32:10",
            "upload_time_iso_8601": "2024-02-29T20:32:10.053391Z",
            "url": "https://files.pythonhosted.org/packages/07/58/119fe542589cd8404ff55d430e95e75f660fb5a93fcde01aaa3f1db3ea34/gseapy-1.1.2-cp39-cp39-manylinux_2_12_i686.manylinux2010_i686.manylinux_2_17_i686.manylinux2014_i686.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "3d0aa150f53f6e55961f048fece4543a11fd2f912eb81cd9cb892b4b12d244b5",
                "md5": "26b2299c887e2590dfeee0fc7bf35302",
                "sha256": "cf76e98a7c66e2937538cfdbe6153b45b66656c6cbbe4a11fe45957cde63b7b0"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp39-cp39-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "has_sig": false,
            "md5_digest": "26b2299c887e2590dfeee0fc7bf35302",
            "packagetype": "bdist_wheel",
            "python_version": "cp39",
            "requires_python": ">=3.7",
            "size": 1309047,
            "upload_time": "2024-02-29T20:32:12",
            "upload_time_iso_8601": "2024-02-29T20:32:12.839149Z",
            "url": "https://files.pythonhosted.org/packages/3d/0a/a150f53f6e55961f048fece4543a11fd2f912eb81cd9cb892b4b12d244b5/gseapy-1.1.2-cp39-cp39-manylinux_2_17_x86_64.manylinux2014_x86_64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "2cddb7da6cbbae71309705d3cdcb3008766873e85d74b45af3fcc645db90cabf",
                "md5": "8c1708594a3c7156f8f5b0efb44a0bd7",
                "sha256": "5dedc0e63504d88c5b632fd93023d0000aa5d8ad75ef195ad8951e9d0575a7dc"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp39-cp39-win32.whl",
            "has_sig": false,
            "md5_digest": "8c1708594a3c7156f8f5b0efb44a0bd7",
            "packagetype": "bdist_wheel",
            "python_version": "cp39",
            "requires_python": ">=3.7",
            "size": 357588,
            "upload_time": "2024-02-29T20:31:40",
            "upload_time_iso_8601": "2024-02-29T20:31:40.659121Z",
            "url": "https://files.pythonhosted.org/packages/2c/dd/b7da6cbbae71309705d3cdcb3008766873e85d74b45af3fcc645db90cabf/gseapy-1.1.2-cp39-cp39-win32.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "cca03b90492a9596010e022964094f651c422f594d208467493853de40a30e5c",
                "md5": "b600da15478f1bf17db468250cdff25b",
                "sha256": "ed6831bd7791b82f0d030593463fe1d0240b3c58d15967daac50549be9b361b6"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2-cp39-cp39-win_amd64.whl",
            "has_sig": false,
            "md5_digest": "b600da15478f1bf17db468250cdff25b",
            "packagetype": "bdist_wheel",
            "python_version": "cp39",
            "requires_python": ">=3.7",
            "size": 386178,
            "upload_time": "2024-02-29T20:31:29",
            "upload_time_iso_8601": "2024-02-29T20:31:29.130090Z",
            "url": "https://files.pythonhosted.org/packages/cc/a0/3b90492a9596010e022964094f651c422f594d208467493853de40a30e5c/gseapy-1.1.2-cp39-cp39-win_amd64.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "bc544e09f7d74d0d1778b081fff8853a3ca6d03a951032424691be6d2df6fbea",
                "md5": "924cf84b4cbddd9802e93e23dbdb2e2b",
                "sha256": "fd861b9e75a5103bd4a6bd67925f8f4a3c5b48d51e0ae068f56fb01aa9201e9e"
            },
            "downloads": -1,
            "filename": "gseapy-1.1.2.tar.gz",
            "has_sig": false,
            "md5_digest": "924cf84b4cbddd9802e93e23dbdb2e2b",
            "packagetype": "sdist",
            "python_version": "source",
            "requires_python": ">=3.7",
            "size": 106872,
            "upload_time": "2024-02-29T20:26:18",
            "upload_time_iso_8601": "2024-02-29T20:26:18.936250Z",
            "url": "https://files.pythonhosted.org/packages/bc/54/4e09f7d74d0d1778b081fff8853a3ca6d03a951032424691be6d2df6fbea/gseapy-1.1.2.tar.gz",
            "yanked": false,
            "yanked_reason": null
        }
    ],
    "upload_time": "2024-02-29 20:26:18",
    "github": true,
    "gitlab": false,
    "bitbucket": false,
    "codeberg": false,
    "github_user": "zqfang",
    "github_project": "gseapy",
    "travis_ci": false,
    "coveralls": false,
    "github_actions": true,
    "requirements": [],
    "tox": true,
    "lcname": "gseapy"
}
        
Elapsed time: 0.20258s