Skip to content

Commit 3f4d997

Browse files
committed
fixing typos
1 parent d1470fb commit 3f4d997

File tree

20 files changed

+63
-63
lines changed

20 files changed

+63
-63
lines changed

astroquery/atomic/core.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -280,7 +280,7 @@ def _get_default_form_values(self, form):
280280
# ignore the submit and reset buttons
281281
if elem.get('type') in ['submit', 'reset']:
282282
continue
283-
# check boxes: enabled boxes have the value "on" if not specificed
283+
# check boxes: enabled boxes have the value "on" if not specified
284284
# otherwise. Found out by debugging, perhaps not documented.
285285
if elem.get('type') == 'checkbox' and elem.get('checked') in ["", "checked"]:
286286
value = elem.get('value', 'on')

astroquery/besancon/core.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -166,7 +166,7 @@ def _parse_result(self, response, verbose=False, retrieve_file=True):
166166
raise ValueError("Errors: " + "\n".join(errors))
167167

168168
if verbose:
169-
print("File is %s and can be aquired from %s" % (filename,
169+
print("File is %s and can be acquired from %s" % (filename,
170170
self.url_download
171171
+ '/' + filename))
172172

astroquery/cosmosim/core.py

Lines changed: 3 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -561,7 +561,7 @@ def _generate_response_dict(self,response):
561561
Returns
562562
-------
563563
response_dict : dict
564-
A dictionary of some of the repspnse object's methods
564+
A dictionary of some of the response object's methods
565565
"""
566566

567567
R = response
@@ -644,14 +644,14 @@ def general_job_info(self,jobid=None,output=False):
644644
def delete_job(self,jobid=None,squash=None):
645645
"""
646646
A public function which deletes a stored job from the server in any phase.
647-
If no jobid is given, it attemps to use the most recent job (if it exists
647+
If no jobid is given, it attempts to use the most recent job (if it exists
648648
in this session). If jobid is specified, then it deletes the corresponding job,
649649
and if it happens to match the existing current job, that variable gets deleted.
650650
651651
Parameters
652652
----------
653653
jobid : string
654-
The jobid of the sql query. If no jobid is given, it attemps to use the most recent job (if it exists in this session).
654+
The jobid of the sql query. If no jobid is given, it attempts to use the most recent job (if it exists in this session).
655655
output : bool
656656
Print output of response(s) to the terminal
657657

astroquery/eso/core.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -552,7 +552,7 @@ def retrieve_data(self, datasets, cache=True):
552552
fileLink = "http://dataportal.eso.org/dataPortal"+fileId.attrs['value'].split()[1]
553553
filename = self._request("GET", fileLink, save=True)
554554
files.append(system_tools.gunzip(filename))
555-
self._session.redirect_cache.clear() # EMpty the redirect cache of this request session
555+
self._session.redirect_cache.clear() # Empty the redirect cache of this request session
556556
log.info("Done!")
557557
if (not return_list) and (len(files)==1):
558558
files = files[0]

astroquery/irsa/core.py

Lines changed: 3 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -146,7 +146,7 @@ def query_region(self, coordinates=None, catalog=None, spatial='Cone',
146146
may also be used.
147147
polygon : list, [Required for spatial is ``'Polygon'``]
148148
A list of ``(ra, dec)`` pairs (as tuples), in decimal degrees,
149-
outlinining the polygon to search in. It can also be a list of
149+
outlining the polygon to search in. It can also be a list of
150150
`astropy.coordinates` object or strings that can be parsed by
151151
`astropy.coordinates.ICRS`.
152152
get_query_payload : bool, optional
@@ -202,7 +202,7 @@ def query_region_async(self, coordinates=None, catalog=None,
202202
may also be used.
203203
polygon : list, [Required for spatial is ``'Polygon'``]
204204
A list of ``(ra, dec)`` pairs (as tuples), in decimal degrees,
205-
outlinining the polygon to search in. It can also be a list of
205+
outlining the polygon to search in. It can also be a list of
206206
`astropy.coordinates` object or strings that can be parsed by
207207
`astropy.coordinates.ICRS`.
208208
get_query_payload : bool, optional
@@ -257,7 +257,7 @@ def _parse_spatial(self, spatial, coordinates, radius=None, width=None,
257257
may also be used.
258258
polygon : list, [Required for spatial is ``'Polygon'``]
259259
A list of ``(ra, dec)`` pairs as tuples of
260-
`astropy.coordinates.Angle`s outlinining the polygon to search in.
260+
`astropy.coordinates.Angle`s outlining the polygon to search in.
261261
It can also be a list of `astropy.coordinates` object or strings
262262
that can be parsed by `astropy.coordinates.ICRS`.
263263

astroquery/irsa_dust/core.py

Lines changed: 8 additions & 8 deletions
Original file line numberDiff line numberDiff line change
@@ -56,7 +56,7 @@ def get_images(self, coordinate, radius=None,
5656
----------
5757
coordinate : str
5858
Can be either the name of an object or a coordinate string
59-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
59+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
6060
Examples of acceptable coordinate strings, can be found `here.
6161
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
6262
radius : str / `~astropy.units.Quantity`, optional
@@ -102,7 +102,7 @@ def get_images_async(self, coordinate, radius=None,
102102
----------
103103
coordinate : str
104104
Can be either the name of an object or a coordinate string
105-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
105+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
106106
Examples of acceptable coordinate strings, can be found `here.
107107
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
108108
radius : str / `~astropy.units.Quantity`, optional
@@ -137,14 +137,14 @@ def get_images_async(self, coordinate, radius=None,
137137
def get_image_list(self, coordinate, radius=None, image_type=None,
138138
timeout=TIMEOUT):
139139
"""
140-
Query function that performes coordinate-based query and returns a list
140+
Query function that performs coordinate-based query and returns a list
141141
of URLs to the Irsa-Dust images.
142142
143143
Parameters
144144
-----------
145145
coordinate : str
146146
Can be either the name of an object or a coordinate string
147-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
147+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
148148
Examples of acceptable coordinate strings, can be found `here.
149149
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
150150
radius : str / `~astropy.units.Quantity`, optional
@@ -181,7 +181,7 @@ def get_extinction_table(self, coordinate, radius=None, timeout=TIMEOUT):
181181
----------
182182
coordinate : str
183183
Can be either the name of an object or a coordinate string
184-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
184+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
185185
Examples of acceptable coordinate strings, can be found `here.
186186
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
187187
radius : str / `~astropy.units.Quantity`, optional
@@ -217,7 +217,7 @@ def get_extinction_table_async(self, coordinate, radius=None,
217217
----------
218218
coordinate : str
219219
Can be either the name of an object or a coordinate string
220-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
220+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
221221
Examples of acceptable coordinate strings, can be found `here.
222222
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
223223
radius : str, optional
@@ -253,7 +253,7 @@ def get_query_table(self, coordinate, radius=None,
253253
----------
254254
coordinate : str
255255
Can be either the name of an object or a coordinate string
256-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
256+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
257257
Examples of acceptable coordinate strings, can be found `here.
258258
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
259259
radius : str / `~astropy.units.Quantity`, optional
@@ -300,7 +300,7 @@ def _args_to_payload(self, coordinate, radius=None):
300300
----------
301301
coordinate : str
302302
Can be either the name of an object or a coordinate string
303-
If a name, must be resolveable by NED, SIMBAD, 2MASS, or SWAS.
303+
If a name, must be resolvable by NED, SIMBAD, 2MASS, or SWAS.
304304
Examples of acceptable coordinate strings, can be found `here
305305
<http://irsa.ipac.caltech.edu/applications/DUST/docs/coordinate.html>`_
306306
radius : str / `~astropy.units.Quantity`, optional

astroquery/lcogt/core.py

Lines changed: 3 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -101,7 +101,7 @@ def query_object_async(self, objstr, catalog=None, cache=True,
101101
get_query_payload=False):
102102
"""
103103
Serves the same function as `query_object`, but
104-
only collects the reponse from the LCOGT IPAC archive and returns.
104+
only collects the response from the LCOGT IPAC archive and returns.
105105
106106
Parameters
107107
----------
@@ -170,7 +170,7 @@ def query_region_async(self, coordinates=None, catalog=None,
170170
may also be used.
171171
polygon : list, [Required for spatial is ``'Polygon'``]
172172
A list of ``(ra, dec)`` pairs (as tuples), in decimal degrees,
173-
outlinining the polygon to search in. It can also be a list of
173+
outlining the polygon to search in. It can also be a list of
174174
`astropy.coordinates` object or strings that can be parsed by
175175
`astropy.coordinates.ICRS`.
176176
get_query_payload : bool, optional
@@ -230,7 +230,7 @@ def _parse_spatial(self, spatial, coordinates, radius=None, width=None,
230230
may also be used.
231231
polygon : list, [Required for spatial is ``'Polygon'``]
232232
A list of ``(ra, dec)`` pairs as tuples of
233-
`astropy.coordinates.Angle`s outlinining the polygon to search in.
233+
`astropy.coordinates.Angle`s outlining the polygon to search in.
234234
It can also be a list of `astropy.coordinates` object or strings
235235
that can be parsed by `astropy.coordinates.ICRS`.
236236

astroquery/ned/core.py

Lines changed: 2 additions & 2 deletions
Original file line numberDiff line numberDiff line change
@@ -442,7 +442,7 @@ def get_image_list(self, object_name, item='image', get_query_payload=False):
442442

443443
def extract_image_urls(self, html_in):
444444
"""
445-
Helper function that uses reges to extract the image urls from the given HTML.
445+
Helper function that uses regexps to extract the image urls from the given HTML.
446446
447447
Parameters
448448
----------
@@ -470,7 +470,7 @@ def get_table(self, object_name, table='photometry', get_query_payload=False,
470470
Specifies the type of data-table that must be fetched for the given object. Defaults to
471471
'photometry'.
472472
output_table_format : int, [optional for photometry]
473-
specifies teh format of the output table. Must be 1, 2 or 3.
473+
specifies the format of the output table. Must be 1, 2 or 3.
474474
Defaults to 1. These options stand for:
475475
(1) Data as Published and Homogenized (mJy)
476476
(2) Data as Published

astroquery/nrao/core.py

Lines changed: 1 addition & 1 deletion
Original file line numberDiff line numberDiff line change
@@ -112,7 +112,7 @@ def _args_to_payload(self, **kwargs):
112112
The type of query to perform. "OBSSUMMARY" is the default, but it
113113
is only valid for VLA/VLBA observations. ARCHIVE will not work at all
114114
because it relies on XML data. OBSERVATION will provide full details
115-
of the soruces observed and under what configurations.
115+
of the sources observed and under what configurations.
116116
source_id : str, optional
117117
A source name (to be parsed by SIMBAD or NED)
118118
get_query_payload : bool, optional

astroquery/nvas/core.py

Lines changed: 3 additions & 3 deletions
Original file line numberDiff line numberDiff line change
@@ -58,7 +58,7 @@ def get_images(self, coordinates, radius=0.25 * u.arcmin, max_rms=10000,
5858
Gets the UVfits files instead of the IMfits files when set to `True`.
5959
Defaults to `False`.
6060
verbose : bool, optional
61-
When `True` print out additional messgages. Defaults to `True`.
61+
When `True` print out additional messages. Defaults to `True`.
6262
get_query_payload : bool, optional
6363
if set to `True` then returns the dictionary sent as the HTTP request.
6464
Defaults to `False`.
@@ -102,7 +102,7 @@ def get_images_async(self, coordinates, radius=0.25 * u.arcmin, max_rms=10000,
102102
Gets the UVfits files instead of the IMfits files when set to `True`.
103103
Defaults to `False`.
104104
verbose : bool, optional
105-
When `True` print out additional messgages. Defaults to `True`.
105+
When `True` print out additional messages. Defaults to `True`.
106106
get_query_payload : bool, optional
107107
if set to `True` then returns the dictionary sent as the HTTP request.
108108
Defaults to `False`.
@@ -172,7 +172,7 @@ def get_image_list(self, coordinates, radius=0.25 * u.arcmin, max_rms=10000,
172172

173173
def extract_image_urls(self, html_in, get_uvfits=False):
174174
"""
175-
Helper function that uses reges to extract the image urls from the given HTML.
175+
Helper function that uses regexps to extract the image urls from the given HTML.
176176
177177
Parameters
178178
----------

0 commit comments

Comments
 (0)