@@ -107,7 +107,7 @@ def __init__(self):
107107 self ._service_api_connection .set_service_params (services , "tesscut" )
108108
109109 def get_sectors (self , * , coordinates = None , radius = 0 * u .deg , product = 'SPOC' , objectname = None ,
110- moving_target = False , mt_type = None ):
110+ moving_target = False , mt_type = None , resolver = None ):
111111 """
112112 Get a list of the TESS data sectors whose footprints intersect
113113 with the given search area.
@@ -152,6 +152,11 @@ def get_sectors(self, *, coordinates=None, radius=0*u.deg, product='SPOC', objec
152152 first majorbody is tried and then smallbody if a matching majorbody is not found.
153153
154154 NOTE: If moving_target is supplied, this argument is ignored.
155+ resolver : str, optional
156+ The resolver to use when resolving a named target into coordinates. Valid options are "SIMBAD" and "NED".
157+ If not specified, the default resolver order will be used. Please see the
158+ `STScI Archive Name Translation Application (SANTA) <https://mastresolver.stsci.edu/Santa-war/>`__
159+ for more information. Default is None.
155160
156161 Returns
157162 -------
@@ -187,7 +192,9 @@ def get_sectors(self, *, coordinates=None, radius=0*u.deg, product='SPOC', objec
187192 else :
188193
189194 # Get Skycoord object for coordinates/object
190- coordinates = parse_input_location (coordinates , objectname )
195+ coordinates = parse_input_location (coordinates = coordinates ,
196+ objectname = objectname ,
197+ resolver = resolver )
191198
192199 # If radius is just a number we assume degrees
193200 radius = Angle (radius , u .deg )
@@ -223,7 +230,8 @@ def get_sectors(self, *, coordinates=None, radius=0*u.deg, product='SPOC', objec
223230 return Table (sector_dict )
224231
225232 def download_cutouts (self , * , coordinates = None , size = 5 , sector = None , product = 'SPOC' , path = "." ,
226- inflate = True , objectname = None , moving_target = False , mt_type = None , verbose = False ):
233+ inflate = True , objectname = None , moving_target = False , mt_type = None , resolver = None ,
234+ verbose = False ):
227235 """
228236 Download cutout target pixel file(s) around the given coordinates with indicated size.
229237
@@ -280,6 +288,11 @@ def download_cutouts(self, *, coordinates=None, size=5, sector=None, product='SP
280288 first majorbody is tried and then smallbody if a matching majorbody is not found.
281289
282290 NOTE: If moving_target is supplied, this argument is ignored.
291+ resolver : str, optional
292+ The resolver to use when resolving a named target into coordinates. Valid options are "SIMBAD" and "NED".
293+ If not specified, the default resolver order will be used. Please see the
294+ `STScI Archive Name Translation Application (SANTA) <https://mastresolver.stsci.edu/Santa-war/>`__
295+ for more information. Default is None.
283296
284297 Returns
285298 -------
@@ -310,7 +323,9 @@ def download_cutouts(self, *, coordinates=None, size=5, sector=None, product='SP
310323 else :
311324
312325 # Get Skycoord object for coordinates/object
313- coordinates = parse_input_location (coordinates , objectname )
326+ coordinates = parse_input_location (coordinates = coordinates ,
327+ objectname = objectname ,
328+ resolver = resolver )
314329
315330 astrocut_request = f"astrocut?ra={ coordinates .ra .deg } &dec={ coordinates .dec .deg } "
316331
@@ -359,7 +374,7 @@ def download_cutouts(self, *, coordinates=None, size=5, sector=None, product='SP
359374 return localpath_table
360375
361376 def get_cutouts (self , * , coordinates = None , size = 5 , product = 'SPOC' , sector = None ,
362- objectname = None , moving_target = False , mt_type = None ):
377+ objectname = None , moving_target = False , mt_type = None , resolver = None ):
363378 """
364379 Get cutout target pixel file(s) around the given coordinates with indicated size,
365380 and return them as a list of `~astropy.io.fits.HDUList` objects.
@@ -408,6 +423,11 @@ def get_cutouts(self, *, coordinates=None, size=5, product='SPOC', sector=None,
408423 first majorbody is tried and then smallbody if a matching majorbody is not found.
409424
410425 NOTE: If moving_target is supplied, this argument is ignored.
426+ resolver : str, optional
427+ The resolver to use when resolving a named target into coordinates. Valid options are "SIMBAD" and "NED".
428+ If not specified, the default resolver order will be used. Please see the
429+ `STScI Archive Name Translation Application (SANTA) <https://mastresolver.stsci.edu/Santa-war/>`__
430+ for more information. Default is None.
411431
412432 Returns
413433 -------
@@ -457,7 +477,9 @@ def get_cutouts(self, *, coordinates=None, size=5, product='SPOC', sector=None,
457477 param_dict ['product' ] = product .upper ()
458478
459479 # Get Skycoord object for coordinates/object
460- coordinates = parse_input_location (coordinates , objectname )
480+ coordinates = parse_input_location (coordinates = coordinates ,
481+ objectname = objectname ,
482+ resolver = resolver )
461483
462484 param_dict ["ra" ] = coordinates .ra .deg
463485 param_dict ["dec" ] = coordinates .dec .deg
@@ -531,7 +553,7 @@ def get_surveys(self, coordinates, *, radius="0d"):
531553 """
532554
533555 # Get Skycoord object for coordinates/object
534- coordinates = parse_input_location (coordinates )
556+ coordinates = parse_input_location (coordinates = coordinates )
535557 radius = Angle (radius , u .deg )
536558
537559 params = {"ra" : coordinates .ra .deg ,
@@ -596,7 +618,7 @@ def download_cutouts(self, coordinates, *, size=5, survey=None, cutout_format="f
596618 Cutout file(s) for given coordinates
597619 """
598620 # Get Skycoord object for coordinates/object
599- coordinates = parse_input_location (coordinates )
621+ coordinates = parse_input_location (coordinates = coordinates )
600622 size_dict = _parse_cutout_size (size )
601623
602624 path = os .path .join (path , '' )
@@ -675,7 +697,7 @@ def get_cutouts(self, coordinates, *, size=5, survey=None):
675697 """
676698
677699 # Get Skycoord object for coordinates/object
678- coordinates = parse_input_location (coordinates )
700+ coordinates = parse_input_location (coordinates = coordinates )
679701
680702 param_dict = _parse_cutout_size (size )
681703 param_dict ["ra" ] = coordinates .ra .deg
@@ -760,7 +782,7 @@ def download_cutouts(self, coordinates, *, size=5, path=".", inflate=True, verbo
760782 """
761783
762784 # Get Skycoord object for coordinates/object
763- coordinates = parse_input_location (coordinates )
785+ coordinates = parse_input_location (coordinates = coordinates )
764786
765787 # Build initial astrocut request
766788 astrocut_request = f"astrocut?ra={ coordinates .ra .deg } &dec={ coordinates .dec .deg } "
@@ -829,7 +851,7 @@ def get_cutouts(self, coordinates, *, size=5):
829851 """
830852
831853 # Get Skycoord object for coordinates/object
832- coordinates = parse_input_location (coordinates )
854+ coordinates = parse_input_location (coordinates = coordinates )
833855
834856 param_dict = _parse_cutout_size (size )
835857
0 commit comments