Example #1
0
This object then parses the data and returns a table parsed with `astropy.io.votable.parse`.

The user-available query tools, `~astroquery.simbad.queries.QueryId`,
`~astroquery.simbad.queries.QueryAroundId`,
`~astroquery.simbad.queries.QueryCoord`, `~astroquery.simbad.queries.QueryCat`,
`~astroquery.simbad.queries.QueryBibobj`,
`~astroquery.simbad.queries.QueryMulti`, all create specific query types
specifying the object or region to search.

The `_Query.execute` command takes that query - e.g., ``query id`` for
`~astroquery.simbad.queries.QueryId` - and wraps it in the appropriate votable commands.  If you want
additional fields returned (e.g., those that you can select on the `Output
Options <http://simbad.u-strasbg.fr/simbad/sim-fout>`__ page), you can specify
them by passing a :class:`~astroquery.simbad.simbad_votable.VoTableDef` object with
different output options specified (as per
`Section 5 of the script documents
<http://simbad.u-strasbg.fr/simbad/sim-help?Page=sim-fscript#VotableFields>`__
).
"""
from astropy.config import ConfigurationItem

SIMBAD_SERVER = ConfigurationItem(
    'simbad_server', ['simbad.u-strasbg.fr', 'simbad.harvard.edu'],
    'Name of the SIMBAD mirror to use.')

from .queries import *
from .result import *
from .simbad_votable import *

votabledef = 'main_id, coordinates'
Example #2
0
     K. Willett, Jun 2011

    :Acknowledgements:

        Based off Adam Ginsburg's Splatalogue search routine:
            http://code.google.com/p/agpy/source/browse/trunk/agpy/query_splatalogue.py

        Service URLs to acquire the VO Tables are taken from Mazzarella et al. (2007)
        The National Virtual Observatory: Tools and Techniques for Astronomical Research,
        ASP Conference Series, Vol. 382., p.165

"""

from astropy.config import ConfigurationItem
NED_SERVER = ConfigurationItem('ned_server',
                               ['http://ned.ipac.caltech.edu/cgi-bin/'],
                               'Name of the NED mirror to use.')

NED_TIMEOUT = ConfigurationItem('timeout', 60,
                                'time limit for connecting to NED server')

# Set input parameters of choice
HUBBLE_CONSTANT = ConfigurationItem(
    'hubble_constant', [73, 70.5],
    'value of the Hubble Constant for many NED queries.')
"""
The correct redshift for NED queries may be chosen by specifying numbers 1, 2, 3 and 4, having the following meanings
(1) To the Reference Frame defined by the 3K CMB
(2) To the Reference Frame defined by the Virgo Infall only
(3) To the Reference Frame defined by the (Virgo + GA) only
(4) To the Reference Frame defined by the (Virgo + GA + Shapley)
Example #3
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
.. topic:: Revision History

    Refactored using common API as a part of Google Summer of Code 2013.

    :Originally contributed by:

        Adam Ginsburg ([email protected])
"""

from astropy.config import ConfigurationItem

NVAS_SERVER = ConfigurationItem('nvas_server', ["https://webtest.aoc.nrao.edu/cgi-bin/lsjouwer/archive-pos.pl"],
                               'Name of the NVAS mirror to use.')
NVAS_TIMEOUT = ConfigurationItem('timeout', 60, 'time limit for connecting to NVAS server')

from .core import Nvas,NvasClass

__all__ = ['Nvas','NvasClass']
Example #4
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
The SIMBAD query tool creates a `script query
<http://simbad.u-strasbg.fr/simbad/sim-fscript>`__ that returns VOtable XML
data that is then parsed into a SimbadResult object.
This object then parses the data and returns a table parsed with `astropy.io.votable.parse`.
"""
from astropy.config import ConfigurationItem

SIMBAD_SERVER = ConfigurationItem(
    'simbad_server', ['simbad.u-strasbg.fr', 'simbad.harvard.edu'],
    'Name of the SIMBAD mirror to use.')

SIMBAD_TIMEOUT = ConfigurationItem(
    'timeout', 60, 'time limit for connecting to Simbad server')

# O defaults to the maximum limit
ROW_LIMIT = ConfigurationItem(
    'row_limit', 0,
    'maximum number of rows that will be fetched from the result.')

from .core import Simbad, SimbadClass

__all__ = ['Simbad', 'SimbadClass']
Example #5
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
MAGPIS Image and Catalog Query Tool
-----------------------------------
.. topic:: Revision History

    Refactored using common API as a part of Google Summer of Code 2013.

    :Originally contributed by:

        Adam Ginsburg ([email protected])

"""
from astropy.config import ConfigurationItem

MAGPIS_SERVER = ConfigurationItem(
    'magpis_server', ["http://third.ucllnl.org/cgi-bin/gpscutout"],
    'Name of the MAGPIS server.')
MAGPIS_TIMEOUT = ConfigurationItem(
    'timeout', 60, 'time limit for connecting to MAGPIS server')

from .core import Magpis, MagpisClass

__all__ = ['Magpis', 'MagpisClass']
Example #6
0
"""
OGLE Query Tool
---------------

:Author: Brian Svoboda ([email protected])

This package is for querying interstellar extinction toward the Galactic bulge
from OGLE-III data
`hosted at. <http://ogle.astrouw.edu.pl/cgi-ogle/getext.py>`_

Note:
  If you use the data from OGLE please refer to the publication by Nataf et al.
  (2012).
"""
from astropy.config import ConfigurationItem

OGLE_SERVER = ConfigurationItem(
    'ogle_server', ['http://ogle.astrouw.edu.pl/cgi-ogle/getext.py'],
    'Name of the OGLE mirror to use.')
OGLE_TIMEOUT = ConfigurationItem(
    'timeout', 60, 'Time limit for connecting to the OGLE server.')

from .core import Ogle, OgleClass

__all__ = ['Ogle', 'OgleClass']

import warnings
warnings.warn(
    "Experimental: OGLE has not yet been refactored to have its API match the rest of astroquery."
)
Example #7
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
Access to Fermi Gamma-ray Space Telescope data.

http://fermi.gsfc.nasa.gov
http://fermi.gsfc.nasa.gov/ssc/data/
"""
from astropy.config import ConfigurationItem

FERMI_URL = ConfigurationItem('fermi_url',
                              ['http://fermi.gsfc.nasa.gov/cgi-bin/ssc/LAT/LATDataQuery.cgi'],
                              "Fermi query URL")
FERMI_TIMEOUT = ConfigurationItem('timeout', 60, 'time limit for connecting to FERMI server')
FERMI_RETRIEVAL_TIMEOUT = ConfigurationItem('retrieval_timeout', 120, 'time limit for retrieving a data file once it has been located')

from .core import FermiLAT, FermiLATClass, GetFermilatDatafile, get_fermilat_datafile

import warnings
warnings.warn("Experimental: Fermi-LAT has not yet been refactored to have its API match the rest of astroquery.")

# clean up namespace - prevents doc warnings.  Unecessary if an `__all__` is added
del ConfigurationItem
Example #8
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
Splatalogue Catalog Query Tool
-----------------------------------

:Author: Adam Ginsburg ([email protected])

:Originally contributed by:

     Magnus Vilehlm Persson ([email protected])
"""
from astropy.config import ConfigurationItem
SLAP_URL = ConfigurationItem("Splatalogue SLAP interface URL (not used).",
                             'http://find.nrao.edu/splata-slap/slap')
QUERY_URL = ConfigurationItem("Splatalogue web interface URL.",
                              'http://www.cv.nrao.edu/php/splat/c_export.php')
SPLATALOGUE_TIMEOUT = ConfigurationItem(
    'timeout', 60, 'default timeout for connecting to server')
LINES_LIMIT = ConfigurationItem('Limit to number of lines exported', 10000)

import load_species_table

from .core import Splatalogue, SplatalogueClass
import utils

__all__ = ['Splatalogue', 'SplatalogueClass']
Example #9
0
"""
<Put Your Tool Name Here>
-------------------------

:author: <your name> (<your email>)
"""

# Make the URL of the server, timeout and other items configurable
# See <http://docs.astropy.org/en/latest/config/index.html#developer-usage>
# for docs and examples on how to do this
# Below is a common use case

from astropy.config import ConfigurationItem

# Set the server mirrors to query
SERVER = ConfigurationItem('server', [
    'http://dummy_server_mirror_1', 'http://dummy_server_mirror_2',
    'http://dummy_server_mirror_n'
], 'put a brief description of the item here')

# Set the timeout for connecting to the server in seconds, here we set it to 30s
TIMEOUT = ConfigurationItem('timeout', 30,
                            'default timeout for connecting to server')

# Now import your public class
# Should probably have the same name as your module

from .core import Dummy, DummyClass

__all__ = ['Dummy', 'DummyClass']
Example #10
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
Besancon Query Tool
-------------------
A tool to query the Besancon model of the galaxy
http://model.obs-besancon.fr/

:Author: Adam Ginsburg ([email protected])
"""
from astropy.config import ConfigurationItem
# maintain a list of URLs in case the user wants to append a mirror
BESANCON_DOWNLOAD_URL = ConfigurationItem(
    'besancon_download_url', [
        'ftp://sasftp.obs-besancon.fr/modele/modele2003/',
        'ftp://sasftp.obs-besancon.fr/modele/',
    ], 'Besancon download URL.  Changed to modele2003 in 2013.')

BESANCON_MODEL_FORM = ConfigurationItem(
    'besancon_model_Form', ["http://model.obs-besancon.fr/modele_form.php"],
    "Besancon model form URL")

BESANCON_PING_DELAY = ConfigurationItem(
    'besancon_ping_delay',
    30.0,
    "Amount of time before pinging the Besancon server to see if the file is ready.  Minimum 30s.",
    cfgtype="float(min=30.0)")

BESANCON_TIMEOUT = ConfigurationItem('besancon_timeout', 30.0,
                                     "Timeout for Besancon query")

from .core import Besancon, BesanconClass
Example #11
0
"""
CosmoSim Database Query Tool
-----------------------------
.. topic:: Revision History

    Access to all cosmological simulations stored in the CosmoSim database, via the uws service.

    http://www.cosmosim.org/uws/query

    :Author: Austen M. Groener <*****@*****.**>
"""

from astropy.config import ConfigurationItem

COSMOSIM_SERVER = ConfigurationItem('cosmosim_server',
                                    ["http://www.cosmosim.org/uws/query"],
                                    'Name of the CosmoSim mirror to use.')

COSMOSIM_TIMEOUT = ConfigurationItem(
    'timeout', 60, 'time limit for connecting to CosmoSim server')

from .core import CosmoSim

__all__ = ['CosmoSim']
Example #12
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
VISTA Image and Catalog Query Tool
-----------------------------------
.. topic:: Revision History

    Contributed by Jonathan Foster ([email protected])

    :Based on the UKIDSS version originally contributed by:

        Thomas Robitalle ([email protected])

        Adam Ginsburg ([email protected])
"""
from astropy.config import ConfigurationItem

VISTA_SERVER = ConfigurationItem('vista_server',
                                 ["http://horus.roe.ac.uk:8080/vdfs/"],
                                 'Name of the VISTA mirror to use.')
VISTA_TIMEOUT = ConfigurationItem('timeout', 60,
                                  'time limit for connecting to VISTA server')

from .core import Vista, VistaClass, clean_catalog

__all__ = ['Vista', 'VistaClass', 'clean_catalog']
Example #13
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
SDSS Spectra/Image/SpectralTemplate Archive Query Tool
------------------------------------------------------

:Author: Jordan Mirocha ([email protected])
"""

from astropy.config import ConfigurationItem

SDSS_SERVER = ConfigurationItem('sdss_server', 'http://data.sdss3.org/sas/dr10',
                                'Link to SDSS website.')

SDSS_MAXQUERY = ConfigurationItem('maxqueries', 1, 'Max number of queries allowed per second')

SDSS_TIMEOUT = ConfigurationItem('timeout', 30,
                                 'Default timeout for connecting to server')

from .core import SDSS, SDSSClass

import warnings
warnings.warn("Experimental: SDSS has not yet been refactored to have its API match the rest of astroquery (but it's nearly there).")

# clean up namespace - prevents doc warnings.  Unecessary if an `__all__` is added
del ConfigurationItem
Example #14
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
Fetches line spectra from the NIST Atomic Spectra Database.
"""
from astropy.config import ConfigurationItem

NIST_SERVER = ConfigurationItem(
    'nist_server', ["http://physics.nist.gov/cgi-bin/ASD/lines1.pl"],
    'Name of the NIST URL to query.')

NIST_TIMEOUT = ConfigurationItem('timeout', 30,
                                 'time limit for connecting to NIST server')

from .core import Nist, NistClass

__all__ = ['Nist', 'NistClass']
Example #15
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
Module to query the NRAO Data Archive for observation summaries.
"""
from astropy.config import ConfigurationItem

NRAO_SERVER = ConfigurationItem('nrao_server', ['https://archive.nrao.edu/archive/ArchiveQuery'],
                               'Name of the NRAO mirror to use.')
NRAO_TIMEOUT = ConfigurationItem('timeout', 60, 'time limit for connecting to NRAO server')


from .core import Nrao,NraoClass

__all__ = ['Nrao','NraoClass']
Example #16
0
from astropy.config import ConfigurationItem

ROW_LIMIT = ConfigurationItem('row_limit', 50, 'maximum number of rows returned (set to -1 for unlimited).')

from .core import Eso, EsoClass

__all__ = ['Eso', 'EsoClass']
Example #17
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
VizieR Query Tool
-----------------

:Author: Julien Woillez ([email protected])

This package is for querying the VizieR service, primarily hosted at: http://vizier.u-strasbg.fr
Note: If the access to catalogues with VizieR was helpful for your research work, the following
acknowledgment would be appreciated::

  This research has made use of the VizieR catalogue access tool, CDS, Strasbourg, France.
  The original description of the VizieR service was published in A&AS 143, 23
"""
from astropy.config import ConfigurationItem

VIZIER_SERVER = ConfigurationItem('vizier_server', [
    'vizier.u-strasbg.fr', 'vizier.nao.ac.jp', 'vizier.hia.nrc.ca',
    'vizier.ast.cam.ac.uk', 'vizier.cfa.harvard.edu',
    'www.ukirt.jach.hawaii.edu', 'vizier.iucaa.ernet.in', 'vizier.china-vo.org'
], 'Name of the VizieR mirror to use.')

from .core import *
Example #18
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
UKIDSS Image and Catalog Query Tool
-----------------------------------
.. topic:: Revision History

    Refactored using common API as a part of Google Summer of Code 2013.

    :Originally contributed by:

        Thomas Robitalle ([email protected])

        Adam Ginsburg ([email protected])
"""
from astropy.config import ConfigurationItem

UKIDSS_SERVER = ConfigurationItem('ukidss_server',
                                  ["http://surveys.roe.ac.uk:8080/wsa/"],
                                  'Name of the UKIDSS mirror to use.')
UKIDSS_TIMEOUT = ConfigurationItem(
    'timeout', 60, 'time limit for connecting to UKIDSS server')

from .core import Ukidss, UkidssClass, clean_catalog

__all__ = ['Ukidss', 'UkidssClass', 'clean_catalog']
Example #19
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
This module contains various methods for querying the IRSA Catalog Query Service(CatQuery)
"""
from astropy.config import ConfigurationItem

IRSA_SERVER = ConfigurationItem(
    'irsa_server', ['http://irsa.ipac.caltech.edu/cgi-bin/Gator/nph-query'],
    'Name of the IRSA mirror to use.')
GATOR_LIST_CATALOGS = ConfigurationItem(
    'gator_list_catalogs',
    ['http://irsa.ipac.caltech.edu/cgi-bin/Gator/nph-scan'],
    'URL from which to list all the public catalogs in IRSA.')
ROW_LIMIT = ConfigurationItem('row_limit', 500,
                              'maximum number of rows to retrieve in result')
TIMEOUT = ConfigurationItem('timeout', 60,
                            'time limit for connecting to the IRSA server')

from .core import Irsa, IrsaClass

__all__ = ['Irsa', 'IrsaClass']
Example #20
0
:Author: Julien Woillez ([email protected])

This package is for querying the VizieR service, primarily hosted at: http://vizier.u-strasbg.fr

Note: If the access to catalogues with VizieR was helpful for your research work, the following
acknowledgment would be appreciated::

  This research has made use of the VizieR catalogue access tool, CDS, Strasbourg, France.
  The original description of the VizieR service was published in A&AS 143, 23
"""
from astropy.config import ConfigurationItem

VIZIER_SERVER = ConfigurationItem('vizier_server', [
    'vizier.u-strasbg.fr', 'vizier.nao.ac.jp', 'vizier.hia.nrc.ca',
    'vizier.ast.cam.ac.uk', 'vizier.cfa.harvard.edu',
    'www.ukirt.jach.hawaii.edu', 'vizier.iucaa.ernet.in', 'vizier.china-vo.org'
], 'Name of the VizieR mirror to use.')

VIZIER_TIMEOUT = ConfigurationItem('timeout', 60,
                                   'default timeout for connecting to server')

ROW_LIMIT = ConfigurationItem(
    'row_limit', 50,
    'maximum number of rows that will be fetched from the result (set to -1 for unlimited).'
)

from .core import Vizier, VizierClass

__all__ = ['Vizier', 'VizierClass']
Example #21
0
# Licensed under a 3-clause BSD style license - see LICENSE.rst
"""
IRSA Galactic Dust Reddening and Extinction Query Tool
------------------------------------------------------
.. topic:: Revision History

    Refactored using common API as a part of Google Summer of Code 2013.

    :Originally contributed by: David Shiga ([email protected])
"""
from astropy.config import ConfigurationItem
# maintain a list of URLs in case the user wants to append a mirror
IRSA_DUST_SERVER = ConfigurationItem(
    'irsa_dust_server', ['http://irsa.ipac.caltech.edu/cgi-bin/DUST/nph-dust'],
    'Name of the irsa_dust server to use')

IRSA_DUST_TIMEOUT = ConfigurationItem(
    'timeout', 30, 'default timeout for connecting to server')

from .core import IrsaDust, IrsaDustClass

__all__ = ['IrsaDust', 'IrsaDustClass']