From 3f93817006519069ff5b21c58ed447b9ff4a1a2d Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 7 Aug 2023 14:14:42 +0200 Subject: [PATCH 01/38] Adding inclusive keyword arguments to the STC constraints. This will keep records that don't have STC coverage declared. We need this for global dataset discovery. --- pyvo/registry/rtcons.py | 72 +++++++++++++++++++++++------- pyvo/registry/tests/test_rtcons.py | 19 ++++++++ 2 files changed, 76 insertions(+), 15 deletions(-) diff --git a/pyvo/registry/rtcons.py b/pyvo/registry/rtcons.py index 2f84a976..08d3d6cf 100644 --- a/pyvo/registry/rtcons.py +++ b/pyvo/registry/rtcons.py @@ -683,7 +683,8 @@ class Spatial(SubqueriedConstraint): takes_sequence = True - def __init__(self, geom_spec, order=6, intersect="covers"): + def __init__(self, geom_spec, + *, order=6, intersect="covers", inclusive=False): """ Parameters @@ -708,8 +709,13 @@ def __init__(self, geom_spec, order=6, intersect="covers"): that completely cover the *geom_spec* region, 'enclosed' for services completely enclosed in the region and 'overlaps' for services which coverage intersect the region. - + inclusive : bool, optional + Normally, this constraint will remove all resources that do + not declare their spatial coverage. Pass inclusive=True to + retain these. """ + self.inclusive = inclusive + def tomoc(s): return _AsIs("MOC({}, {})".format(order, s)) @@ -763,15 +769,24 @@ def get_search_condition(self, service): # MOC-based geometries but does not have a MOC function. if not service.get_tap_capability().get_adql().get_feature( "ivo://org.gavo.dc/std/exts#extra-adql-keywords", "MOC"): - raise RegTAPFeatureMissing("Current RegTAP service does not support MOC.") + raise RegTAPFeatureMissing( + "Current RegTAP service does not support MOC.") # We should compare case-insensitively here, but then we don't # with delimited identifiers -- in the end, that would have to # be handled in dal.vosi.VOSITables. if "rr.stc_spatial" not in service.tables: - raise RegTAPFeatureMissing("stc_spatial missing on current RegTAP service") + raise RegTAPFeatureMissing( + "stc_spatial missing on current RegTAP service") - return super().get_search_condition(service) + self._fillers = { + "geom": geom,} + + cond = super().get_search_condition() + if self.inclusive: + return cond+" OR coverage IS NULL" + else: + return cond class Spectral(SubqueriedConstraint): @@ -811,7 +826,7 @@ class Spectral(SubqueriedConstraint): takes_sequence = True - def __init__(self, spec): + def __init__(self, spec, *, inclusive=False): """ Parameters @@ -822,7 +837,14 @@ def __init__(self, spec): in which case the argument is interpreted as an interval. All resources *overlapping* the interval are returned. Plain floats are interpreted as messenger energy in Joule. + + inclusive : bool, optional + Normally, this constraint will remove all resources that do + not declare their spectral coverage. Pass inclusive=True to + retain these. """ + self.inclusive = inclusive + if isinstance(spec, tuple): self._fillers = { "spec_lo": self._to_joule(spec[0]), @@ -863,11 +885,17 @@ def _to_joule(self, quant): raise ValueError(f"Cannot make a spectral quantity out of {quant}") - def get_search_condition(self, service): + def get_search_condition(self): if "rr.stc_spectral" not in service.tables: - raise RegTAPFeatureMissing("stc_spectral missing on current RegTAP service") - - return super().get_search_condition(service) + raise RegTAPFeatureMissing( + "stc_spectral missing on current RegTAP service") + cond = super().get_search_condition() + if self.inclusive: + return (f"({cond}) OR NOT EXISTS(" + "SELECT 1 FROM rr.stc_spectral AS inner_s WHERE" + " inner_s.ivoid=rr.resource.ivoid)") + else: + return cond class Temporal(SubqueriedConstraint): @@ -903,7 +931,7 @@ class Temporal(SubqueriedConstraint): takes_sequence = True - def __init__(self, times): + def __init__(self, times, *, inclusive=False): """ Parameters @@ -912,7 +940,14 @@ def __init__(self, times): A point in time or time interval to cover. Plain numbers are interpreted as MJD. All resources *overlapping* the interval are returned. + + inclusive : bool, optional + Normally, this constraint will remove all resources that do + not declare their temproal coverage. Pass inclusive=True to + retain these. """ + self.inclusive = inclusive + if isinstance(times, tuple): self._fillers = { "time_lo": self._to_mjd(times[0]), @@ -941,11 +976,18 @@ def _to_mjd(self, quant): " single time instants.") return val - def get_search_condition(self, service): + def get_search_condition(self): if "rr.stc_temporal" not in service.tables: - raise RegTAPFeatureMissing("stc_temporal missing on current RegTAP service") - - return super().get_search_condition(service) + raise RegTAPFeatureMissing( + "stc_temporal missing on current RegTAP service") + + cond = super().get_search_condition() + if self.inclusive: + return (f"({cond}) OR NOT EXISTS(" + "SELECT 1 FROM rr.stc_temporal AS inner_t WHERE" + " inner_t.ivoid=rr.resource.ivoid)") + else: + return cond # NOTE: If you add new Contraint-s, don't forget to add them in diff --git a/pyvo/registry/tests/test_rtcons.py b/pyvo/registry/tests/test_rtcons.py index 7306d132..ab8744f5 100644 --- a/pyvo/registry/tests/test_rtcons.py +++ b/pyvo/registry/tests/test_rtcons.py @@ -293,6 +293,11 @@ def test_moc(self): assert cons.get_search_condition(FAKE_GAVO) == _make_subquery( "rr.stc_spatial", "1 = CONTAINS(MOC('0/1-3 3/'), coverage)") + def test_moc_and_inclusive(self): + cons = registry.Spatial("0/1-3 3/", inclusive=True) + assert cons.get_search_condition(FAKE_GAVO + ) == "1 = CONTAINS(MOC('0/1-3 3/'), coverage) OR coverage IS NULL" + def test_SkyCoord(self): cons = registry.Spatial(SkyCoord(3 * u.deg, -30 * u.deg)) assert cons.get_search_condition(FAKE_GAVO) == _make_subquery( @@ -390,6 +395,13 @@ def test_frequency(self): "rr.stc_spectral", "1.32521403e-24 BETWEEN spectral_start AND spectral_end")) + def test_frequency_and_inclusive(self): + cons = registry.Spectral(2 * u.GHz, inclusive=True) + assert (cons.get_search_condition(FAKE_GAVO) + == "(1.32521403e-24 BETWEEN spectral_start AND spectral_end)" + " OR NOT EXISTS(SELECT 1 FROM rr.stc_spectral AS inner_s" + " WHERE inner_s.ivoid=rr.resource.ivoid)") + def test_frequency_interval(self): cons = registry.Spectral((88 * u.MHz, 102 * u.MHz)) assert (cons.get_search_condition(FAKE_GAVO) @@ -414,6 +426,13 @@ def test_plain_float(self): "rr.stc_temporal", "1 = ivo_interval_overlaps(time_start, time_end, 54130, 54200)")) + def test_plain_float_and_inclusive(self): + cons = registry.Temporal((54130, 54200), inclusive=True) + assert (cons.get_search_condition(FAKE_GAVO) + == "(1 = ivo_interval_overlaps(time_start, time_end, 54130, 54200))" + " OR NOT EXISTS(SELECT 1 FROM rr.stc_temporal AS inner_t" + " WHERE inner_t.ivoid=rr.resource.ivoid)") + def test_single_time(self): cons = registry.Temporal(Time('2022-01-10')) assert (cons.get_search_condition(FAKE_GAVO) From 0ca75e43e3c3c6b98380139ff26a1a8c53f9a5e8 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 7 Aug 2023 16:48:16 +0200 Subject: [PATCH 02/38] Adding a discover sub-tree to hold global discovery code Also, adding a draft for a simple global image discovery module. --- pyvo/discover/__init__.py | 6 + pyvo/discover/image.py | 258 ++++++++++++++++++++++++++++++++++++++ 2 files changed, 264 insertions(+) create mode 100644 pyvo/discover/__init__.py create mode 100644 pyvo/discover/image.py diff --git a/pyvo/discover/__init__.py b/pyvo/discover/__init__.py new file mode 100644 index 00000000..02fdd8fb --- /dev/null +++ b/pyvo/discover/__init__.py @@ -0,0 +1,6 @@ +# Licensed under a 3-clause BSD style license - see LICENSE.rst +""" +Various functions dealing with global data disovery. +""" + +from .image import discover_images diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py new file mode 100644 index 00000000..86fd142e --- /dev/null +++ b/pyvo/discover/image.py @@ -0,0 +1,258 @@ +# Licensed under a 3-clause BSD style license - see LICENSE.rst +""" +Global image discovery. + +This module is intended to cover the much-requested use case "give me all +images with properties x, y, and z, where these properties for now is the +location in space, time, and spectrum; sensitivity clearly would be great, +but that needs standard work. + +The code here looks for data in SIA1, SIA2, and Obscore services for now. +""" + +from enum import IntEnum +from typing import List, Optional, Set, Tuple, TYPE_CHECKING + +from astropy import units as u +from astropy.coordinates import SkyCoord + +from ..dal.sia2 import ObsCoreRecord +from .. import registry + + +# imports for type hints +from astropy.units.quantity import Quantity +from ..registry.regtap import RegistryResults, RegistryResource +from ..dal.sia import SIARecord + + +def _clean_for(records: RegistryResults, to_remove: Set[str]): + """ cleans records with ivoids in to_remove from records. + + This modified records in place. + """ + indexes_to_remove = [] + for index, rec in enumerate(records): + if rec["ivoid"] in to_remove: + indexes_to_remove.append(index) + + # I'm not happy about in-place modifications using a private attribute, + # either, but it seems constructing DALResults on the fly is + # really painful, too. + + # TODO: Oh dang... who do I take out rows for the _votable? + records._votable.resources[0].tables[0].remove_rows(indexes_to_remove) + + +def sia1_to_obscore(sia1_result: SIARecord) -> ObsCoreRecord: + """returns an obscore record filled from SIA1 metadata. + + This probably is a bad idea given the way ObsCoreRecord is done; + we probably need to do per-service mapping. + """ + raise NotImplementedError("We need a SIA1 -> Obscore mapping") + + +class _ImageDiscoverer: + """A management class for VO global image discovery. + + This encapsulates all of constraints, service lists, results, and + diagnostics. This probably should not be considered API but + rather as an implementation detail of discover_images. + + For now, we expose several methods to be called in succession + (see discover_images); that's because we *may* want to make + this API after all and admit user manipulation of our state + in between the larger steps. + + See discover_images for a discussion of its constructor parameters. + """ + def __init__(self, space, spectrum, time, inclusive): + self.space, self.spectrum, self.time = space, spectrum, time + if self.space: + self.center = SkyCoord(self.space[0], self.space[1], unit='deg') + self.radius = self.space[2]*u.deg + + self.inclusive = inclusive + self.result: List[ObsCoreRecord] = [] + self.log: List[str] = [] + + def collect_services(self): + """fills the X_recs attributes with resources declaring coverage + for our constraints. + + X at this point is sia1, sia2, and obscore. + + It tries to filter out as many duplicates (i.e., services operating on + the same data collections) as it can. The order of preference is + Obscore, SIA2, SIA. + """ + constraints = [] + if self.space: + constraints.append( + registry.Spatial(self.space, inclusive=self.inclusive)) + if self.spectrum: + constraints.append( + registry.Spectral(self.spectrum, inclusive=self.inclusive)) + if self.time: + constraints.append( + registry.Temporal(self.time, inclusive=self.inclusive)) + + self.sia1_recs = registry.search( + registry.Servicetype("sia"), *constraints) + self.sia2_recs = registry.search( + registry.Servicetype("sia2"), *constraints) + self.obscore_recs = registry.search( + registry.Datamodel("obscore"), *constraints) + + # Now remove resources presumably operating on the same underlying + # data collection. First, we deselect by ivoid, where a more powerful + # interface is available + def ids(recs): + return set(r.ivoid for r in recs) + + _clean_for(self.sia1_recs, + ids(self.sia2_recs)|ids(self.obscore_recs)) + _clean_for(self.sia2_recs, ids(self.obscore_recs)) + + # TODO: use futher heuristics to further cut down on dupes: + # Use relationships. I think we should tell people to use + # IsDerivedFrom for SIA2 services built on top of TAP services. + + def _query_one_sia1(self, rec: RegistryResource): + """runs our query against a SIA1 capability of rec. + + Since SIA1 cannot do spectral and temporal constraints itself, + we do them client-side provided sufficient metadata is present. + If metadata is missing, we keep or discard accoding to + self.inclusive. + """ + svc = rec.get_service("sia") + for res in svc.search(pos=self.center, size=self.radius, + intersect='overlaps'): + new_rec = sia1_to_obscore(res) + + if not inclusive and self.spectral: + if not new_rec.em_min={meters})") + if self.time: + mjd = self.time.mjd + where_parts.append(f"(t_min<={mjd} AND t_max>={mjd})") + + where_clause = "WHERE "+(" AND ".join(where_parts)) + + for rec in self.obscore_recs: + try: + self._query_one_obscore(rec, where_clause) + except Exception as msg: + self.log.append(f"Obscore {rec['ivoid']} skipped: {msg}") + + def query_services(self): + """queries the discovered image services according to our + constraints. + + This creates fills the results and the log attributes. + """ + self._query_sia1() + self._query_sia2() + self._query_obscore() + + +def discover_images( + space: Optional[Tuple[float, float, float]]=None, + spectrum: Optional[Quantity]=None, + time: Optional[float]=None, + inclusive: bool=False + ) -> Tuple[List[ObsCoreRecord], List[str]]: + """returns a collection of ObsCoreRecord-s matching certain constraints + and a list of log lines. + + Parameters + ---------- + + space : + An optional tuple of ra, dec, and the search radius, all in degrees; + images returned must intersect a spherical circle described in this + way. + spectrum : + An astropy quantity convertible to a (vacuum) wavelength; images + must cover this point in the (electromagnetic) spectrum. + time : + An astropy time that must be in the observation time of the image + (if it declares a time). + inclusive : + Set to True to incluse services that do not declare their + STC coverage. By 2023, it's a good idea to do that as many + relevant archives do not do that. + + When an image has insufficient metadata to evaluate a constraint, it + is excluded; this mimics the behaviour of SQL engines that consider + comparisons with NULL-s false. + """ + discoverer = _ImageDiscoverer(space, spectrum, time, inclusive) + discoverer.collect_services() + discoverer.query_services() + # TODO: We should un-dupe by image access URL + # TODO: We could compute SODA cutout URLs here in addition. + return discoverer.result, discoverer.log From d331c43197be6020262649001435e16ad8d0f3bc Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 28 Aug 2023 16:13:51 +0200 Subject: [PATCH 03/38] Fleshing out global image discovery --- pyvo/discover/image.py | 121 +++++++++++++++++++++++++---------------- 1 file changed, 75 insertions(+), 46 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 86fd142e..b5554ad0 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -21,36 +21,62 @@ # imports for type hints +from typing import List, Set from astropy.units.quantity import Quantity -from ..registry.regtap import RegistryResults, RegistryResource from ..dal.sia import SIARecord -def _clean_for(records: RegistryResults, to_remove: Set[str]): - """ cleans records with ivoids in to_remove from records. +class Queriable: + """A facade for a queriable service. - This modified records in place. - """ - indexes_to_remove = [] - for index, rec in enumerate(records): - if rec["ivoid"] in to_remove: - indexes_to_remove.append(index) + We keep these rather than work on + `pyvo.registry.regtap.RegistryResource`-s directly because the latter + actually live in VOTables which are very hard to manipulate. - # I'm not happy about in-place modifications using a private attribute, - # either, but it seems constructing DALResults on the fly is - # really painful, too. + They are constructed with a resource record. + """ + def __init__(self, res_rec): + self.res_rec = res_rec + self.ivoid = res_rec.ivoid - # TODO: Oh dang... who do I take out rows for the _votable? - records._votable.resources[0].tables[0].remove_rows(indexes_to_remove) +class ImageFound(obscore.ObsCoreMetadata): + """Obscore metadata for a found record. -def sia1_to_obscore(sia1_result: SIARecord) -> ObsCoreRecord: - """returns an obscore record filled from SIA1 metadata. + We're pulling these out from the various VOTables that we + retrieve because we need to do some manipulation of them + that's simpler to do if they are proper Python objects. - This probably is a bad idea given the way ObsCoreRecord is done; - we probably need to do per-service mapping. + This is an implementation detail, though; eventually, we're + turning these into an astropy table and further into a VOTable + to make this as compatible with the DAL services as possible. """ - raise NotImplementedError("We need a SIA1 -> Obscore mapping") + def __init__(self, **kwargs): + for k, v in kwargs.items() + setattr(self, k, v) + + @classmethod + def from_obscore_recs(cls, obscore_result): + return TODO + + @classmethod + def from_sia2_recs(cls, sia2_result): + return TODO + + @classmethod + def from_sia1_recs(cls, sia1_result, filter_func): + result = [] + for rec in sia1_result: + if filter_func(rec): + result.append(cls(**mapped)) + return result + + +def _clean_for(records: List[Queriable], ivoids_to_remove: Set[str]): + """returns the Queriables in records the ivoids of which are + not in ivoids_to_remove. + """ + return [r for r in records if r.ivoid not in ivoids_to_remove] class _ImageDiscoverer: @@ -98,12 +124,12 @@ def collect_services(self): constraints.append( registry.Temporal(self.time, inclusive=self.inclusive)) - self.sia1_recs = registry.search( - registry.Servicetype("sia"), *constraints) - self.sia2_recs = registry.search( - registry.Servicetype("sia2"), *constraints) - self.obscore_recs = registry.search( - registry.Datamodel("obscore"), *constraints) + self.sia1_recs = [Queriable(r) for r in registry.search( + registry.Servicetype("sia"), *constraints)] + self.sia2_recs = [Queriable(r) for r in registry.search( + registry.Servicetype("sia2"), *constraints)] + self.obscore_recs = [Queriable(r) for r in registry.search( + registry.Datamodel("obscore"), *constraints)] # Now remove resources presumably operating on the same underlying # data collection. First, we deselect by ivoid, where a more powerful @@ -111,15 +137,15 @@ def collect_services(self): def ids(recs): return set(r.ivoid for r in recs) - _clean_for(self.sia1_recs, + self.sia1_recs = _clean_for(self.sia1_recs, ids(self.sia2_recs)|ids(self.obscore_recs)) - _clean_for(self.sia2_recs, ids(self.obscore_recs)) + self.sia2_recs = _clean_for(self.sia2_recs, ids(self.obscore_recs)) # TODO: use futher heuristics to further cut down on dupes: # Use relationships. I think we should tell people to use # IsDerivedFrom for SIA2 services built on top of TAP services. - def _query_one_sia1(self, rec: RegistryResource): + def _query_one_sia1(self, rec: Queriable): """runs our query against a SIA1 capability of rec. Since SIA1 cannot do spectral and temporal constraints itself, @@ -127,18 +153,21 @@ def _query_one_sia1(self, rec: RegistryResource): If metadata is missing, we keep or discard accoding to self.inclusive. """ - svc = rec.get_service("sia") - for res in svc.search(pos=self.center, size=self.radius, - intersect='overlaps'): - new_rec = sia1_to_obscore(res) - + def non_spatial_filter(sia1_rec): if not inclusive and self.spectral: if not new_rec.em_min Date: Thu, 31 Aug 2023 11:57:32 +0200 Subject: [PATCH 04/38] Fleshing out global image discovery. This moves towards using a few internal classes to represent found services and datasets to work around the inflexibility of the VOTables underlying DALResults. Perhaps we should one day move back to the DALResults -- I think having some sort of view on them would actually be a smart thing. --- pyvo/discover/image.py | 92 +++++++++++++++++++++++++++++------------- 1 file changed, 64 insertions(+), 28 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index b5554ad0..eaf1a34e 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -10,20 +10,18 @@ The code here looks for data in SIA1, SIA2, and Obscore services for now. """ -from enum import IntEnum -from typing import List, Optional, Set, Tuple, TYPE_CHECKING +import functools from astropy import units as u from astropy.coordinates import SkyCoord -from ..dal.sia2 import ObsCoreRecord +from ..dam import obscore from .. import registry # imports for type hints -from typing import List, Set +from typing import List, Optional, Set, Tuple from astropy.units.quantity import Quantity -from ..dal.sia import SIARecord class Queriable: @@ -40,6 +38,16 @@ def __init__(self, res_rec): self.ivoid = res_rec.ivoid +@functools.cache +def obscore_column_names(): + """returns the names of obscore columns. + + For lack of alternatives, I pull them out of ObsCoreMetadata for now. + """ + return [name for name in dir(obscore.ObsCoreMetadata()) + if not name.startswith("_")] + + class ImageFound(obscore.ObsCoreMetadata): """Obscore metadata for a found record. @@ -51,25 +59,47 @@ class ImageFound(obscore.ObsCoreMetadata): turning these into an astropy table and further into a VOTable to make this as compatible with the DAL services as possible. """ - def __init__(self, **kwargs): - for k, v in kwargs.items() + attr_names = set(obscore_column_names()) + + def __init__(self, obscore_record): + for k, v in obscore_record.items(): + if k not in self.attr_names: + raise TypeError( + f"ImageFound does not accept {k} keys") setattr(self, k, v) @classmethod def from_obscore_recs(cls, obscore_result): - return TODO - - @classmethod - def from_sia2_recs(cls, sia2_result): - return TODO + ap_table = obscore_result.to_table() + our_keys = [n for n in ap_table.colnames if n in cls.attr_names] + for row in obscore_result: + yield cls(dict(zip(our_keys, (row[n] for n in our_keys)))) @classmethod def from_sia1_recs(cls, sia1_result, filter_func): - result = [] for rec in sia1_result: - if filter_func(rec): - result.append(cls(**mapped)) - return result + if not filter_func(rec): + continue + + mapped = { + "dataproduct_type": "image" if rec.naxes == 2 else "cube", + "access_url": rec.acref, + "bandpass_hilimit": rec.em_max.to(u.m).value, + "bandpass_lolimit": rec.em_min.to(u.m).value, + # Sigh. Try to guess exposure time? + "t_min": rec.dateobs, + "t_max": rec.dateobs, + "access_estsize": rec.filesize/1024, + "access_format": rec.format, + "instrument_name": rec.instr, + "s_xsel1": rec.naxis[0], + "s_xsel2": rec.naxis[1], + "s_ra": rec.pos[0], + "s_dec": rec.pos[1], + "obs_title": rec.title, + # TODO: do more (s_resgion!) on the basis of the WCS parts + } + yield cls(mapped) def _clean_for(records: List[Queriable], ivoids_to_remove: Set[str]): @@ -100,7 +130,7 @@ def __init__(self, space, spectrum, time, inclusive): self.radius = self.space[2]*u.deg self.inclusive = inclusive - self.result: List[ObsCoreRecord] = [] + self.result: List[obscore.ObsCoreMetadata] = [] self.log: List[str] = [] def collect_services(self): @@ -154,11 +184,18 @@ def _query_one_sia1(self, rec: Queriable): self.inclusive. """ def non_spatial_filter(sia1_rec): - if not inclusive and self.spectral: - if not new_rec.em_min={meters})") if self.time: - mjd = self.time.mjd + mjd = self.time.mjd.value where_parts.append(f"(t_min<={mjd} AND t_max>={mjd})") where_clause = "WHERE "+(" AND ".join(where_parts)) @@ -253,8 +289,8 @@ def discover_images( spectrum: Optional[Quantity]=None, time: Optional[float]=None, inclusive: bool=False - ) -> Tuple[List[ObsCoreRecord], List[str]]: - """returns a collection of ObsCoreRecord-s matching certain constraints + ) -> Tuple[List[obscore.ObsCoreMetadata], List[str]]: + """returns a collection of ObsCoreMetadata-s matching certain constraints and a list of log lines. Parameters From 9327e7c854578813784a466ff1f59ff1adff521f Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 10 Oct 2023 14:47:54 +0200 Subject: [PATCH 05/38] Adding a "learnable" mocker for requests. That's a class that can cache responses to request calls and replay them at testing time. We want that for the global discovery because without it writing tests will be really tedious. --- docs/utils/testing.rst | 47 ++++++++++++++++++ pyvo/discover/__init__.py | 2 +- pyvo/discover/image.py | 8 +-- .../POST-reg.g-vo.org--%9TAGj9w | 27 ++++++++++ .../POST-reg.g-vo.org--%9TAGj9w.meta | Bin 0 -> 2981 bytes pyvo/discover/tests/test_imagediscovery.py | 25 ++++++++++ 6 files changed, 104 insertions(+), 5 deletions(-) create mode 100644 docs/utils/testing.rst create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w.meta create mode 100644 pyvo/discover/tests/test_imagediscovery.py diff --git a/docs/utils/testing.rst b/docs/utils/testing.rst new file mode 100644 index 00000000..9f254e78 --- /dev/null +++ b/docs/utils/testing.rst @@ -0,0 +1,47 @@ +.. _pyvo-testing: + +****************************************** +Helpers for Testing (`pyvo.utils.testing`) +****************************************** + +This package contains a few helpers to make testing pyvo code simpler. + + +The LearnableRequestMocker +-------------------------- + +By its nature, much of pyVO is about talking to remote services. +Talking to these remote services in order to test pyVO code +makes test runs dependent on the status of external resources and may be +slow. It is therefore desirable to “can” responses to a large extent, +i.e., use live responses to define the test fixture. This is what +`pyvo.utils.testing.LearnableRequestMocker` tries to support. + +To use it, define a fixture for the mocker, somewhat like this:: + + @pytest.fixture + def _all_constraint_responses(requests_mock): + matcher = LearnableRequestMocker("image-with-all-constraints") + requests_mock.add_matcher(matcher) + +The first constructor argument is a fixture name that should be unique +among all the fixtures in a given subdirectory. + +When “training“ your mocker, run ``pytest --remote-data=any``. This +will create one or more pairs of files in the cache directory, which is +a sibling of the current file called ``data/``. Each +request produces two files: + +* .meta: a pickle of the request and selected response + metadata. You probably do not want to edit this. +* : the resonse body, which you may very well want to edit. + +All these must become part of the package for later tests to run without +network interaction. + +When the upstream response changes, all you have to do is remove the +cached files and re-run test with ``--remote-data=any``. + +We do not yet have a good plan for how to preserve edits made to the +test files. Let us see how far we get without opening that can of +worms. diff --git a/pyvo/discover/__init__.py b/pyvo/discover/__init__.py index 02fdd8fb..dc6fc609 100644 --- a/pyvo/discover/__init__.py +++ b/pyvo/discover/__init__.py @@ -3,4 +3,4 @@ Various functions dealing with global data disovery. """ -from .image import discover_images +from .image import images_globally diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index eaf1a34e..26889344 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -144,13 +144,13 @@ def collect_services(self): Obscore, SIA2, SIA. """ constraints = [] - if self.space: + if self.space is not None: constraints.append( registry.Spatial(self.space, inclusive=self.inclusive)) - if self.spectrum: + if self.spectrum is not None: constraints.append( registry.Spectral(self.spectrum, inclusive=self.inclusive)) - if self.time: + if self.time is not None: constraints.append( registry.Temporal(self.time, inclusive=self.inclusive)) @@ -284,7 +284,7 @@ def query_services(self): self._query_obscore() -def discover_images( +def images_globally( space: Optional[Tuple[float, float, float]]=None, spectrum: Optional[Quantity]=None, time: Optional[float]=None, diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w new file mode 100644 index 00000000..f657c32d --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w @@ -0,0 +1,27 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w.meta new file mode 100644 index 0000000000000000000000000000000000000000..c101d81541ca619c69dc659d854e9a10dd89f26b GIT binary patch literal 2981 zcmdT`-EY%Y6t6}~JIW{>+N5b9We-IyCQh8tk09|7(iF-J7re< z8`KNN$Bbjq%@%hKX#HuoSl0LSN?uMJA({1x^^4__UeQZRCTCFzgK`JS>rO9Z_wz<6 z-!^5wTq;-cM)_g6^sus3HGUwsPq@HBA=C3xQs*rN|=88^d3m;C|j>0~dk1pYL-e zc{P>9A{D^F?iKH;FV_$zFHJBI2-1Q$Wh^LA7rChzZ_MK9GH)nt0JDfTGazR?Fsh36 z!=eA-a_A?MNnzmgQ30M#GB`<5l>)1%CI8e>#d32V!a1~&#ZJ@{re~BdqPRi=AK5j9 zkt%X}D)a^{(X9hEprI>MspFI_D?4P3$D}YR683jw;J_?bcX#4*R4|rCsY<9IbB(qdL- zxrn!cQP=e+7qC{8Bc4BrpT)IJ7WVC@?_%4^h$z?ht!ezzAInQioyLokMz{CK@?V6E zPwzHsttXFa2QQj;fp=a%>Nc85q1Pz;`_YyiBZkG4!?OL7yZHPG-mj#Z`URsFZf9`=v@X`LTkrr#)`; zUNssmO$6z&P<52c#F#n6RAF8+a%X?9`arMFrKK}s7bFvMF7>3-J~`GNzs4#5_YF$5 zdQ3;5u9T}t>j1Y%7XKWJ=mt>@8)H&kK7B84g=*fS2bwnSg{^2!H7tTVk`x339fa%j zbkEui6rUnt^cpqSEHf_*j zEr%nt0@w;khUHX^V%1$49bvglOvaVSs+wqL>UNM^x}tSr;zEr+pWUb9^ROT4{{r`b B6QlqD literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py new file mode 100644 index 00000000..217e2e90 --- /dev/null +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -0,0 +1,25 @@ +# Licensed under a 3-clause BSD style license - see LICENSE.rst +""" +Tests for pyvo.discover.image +""" + +import pytest + +from astropy import time +from astropy import units as u + +from pyvo import discover +from pyvo.utils.testing import LearnableRequestMocker + + +@pytest.fixture +def _all_constraint_responses(requests_mock): + matcher = LearnableRequestMocker("image-with-all-constraints") + requests_mock.add_matcher(matcher) + + +def test_with_all_constraints(_all_constraint_responses): + res = discover.images_globally( + space=(132, 14, 0.1), + time=time.Time(58794.9, format="mjd"), + spectrum=600*u.eV) From 5e3027aca51645e4069542d5f98c7ab9cbf048f1 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 20 Oct 2023 14:07:40 +0200 Subject: [PATCH 06/38] Making a first global discovery query work. This changes the internal parameter processing in _ImageDiscoverer to plain floats instead of quantities (which turned out to be painful with SIA1) We also change the naming scheme for LearnableRequestMockers because the old one was not producing unique names. Also, joined tables in regtap are now alphabetically sorted to get more reproducable RegTAP queries, which we Finally, we have to do a quick fix to SIA2, which currently is broken with the registry in main; this should be backed out when sia2 is fixed in main. --- docs/utils/testing.rst | 5 +- pyvo/discover/image.py | 84 ++++++++++++------ ...siap.xml_intersect=['over-KwbduA7iAm3yI+JS | 28 ++++++ ...xml_intersect=['over-KwbduA7iAm3yI+JS.meta | Bin 0 -> 1758 bytes ...iap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ | 18 ++++ ...xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta | Bin 0 -> 1853 bytes ...rg-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%} | 17 ++-- ...ync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta | Bin 0 -> 3019 bytes ...org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY | 25 ++++++ ...nc_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta} | Bin 2981 -> 2885 bytes ...org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW | 25 ++++++ ...ync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta | Bin 0 -> 2895 bytes pyvo/discover/tests/test_imagediscovery.py | 17 +++- 13 files changed, 180 insertions(+), 39 deletions(-) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org--%9TAGj9w => POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%} (64%) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org--%9TAGj9w.meta => POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta} (56%) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta diff --git a/docs/utils/testing.rst b/docs/utils/testing.rst index 9f254e78..dbb3f8ae 100644 --- a/docs/utils/testing.rst +++ b/docs/utils/testing.rst @@ -37,7 +37,10 @@ request produces two files: * : the resonse body, which you may very well want to edit. All these must become part of the package for later tests to run without -network interaction. +network interaction. The is intended to facilitate figuring +out which response belongs to which request; it consists of the method, +the host, the start of the payload (if any), and hashes of the full URL +and a payload. When the upstream response changes, all you have to do is remove the cached files and re-run test with ``--remote-data=any``. diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 26889344..6acb6e0a 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -13,6 +13,7 @@ import functools from astropy import units as u +from astropy import time from astropy.coordinates import SkyCoord from ..dam import obscore @@ -37,6 +38,9 @@ def __init__(self, res_rec): self.res_rec = res_rec self.ivoid = res_rec.ivoid + def __str__(self): + return f"<{self.ivoid}>" + @functools.cache def obscore_column_names(): @@ -123,14 +127,29 @@ class _ImageDiscoverer: See discover_images for a discussion of its constructor parameters. """ + # Constraint defaults + # a float in metres + spectrum = None + # an MJD float + time = None + # a center as a 2-tuple in ICRS degrees + center = None + # a radius as a float in degrees + radius = None + def __init__(self, space, spectrum, time, inclusive): - self.space, self.spectrum, self.time = space, spectrum, time - if self.space: - self.center = SkyCoord(self.space[0], self.space[1], unit='deg') - self.radius = self.space[2]*u.deg + if space: + self.center = (space[0], space[1]) + self.radius = space[2] + + if spectrum is not None: + self.spectrum = spectrum.to(u.m, equivalencies=u.spectral()).value + # a float in MJD + if time is not None: + self.time = time.mjd self.inclusive = inclusive - self.result: List[obscore.ObsCoreMetadata] = [] + self.results: List[obscore.ObsCoreMetadata] = [] self.log: List[str] = [] def collect_services(self): @@ -144,12 +163,14 @@ def collect_services(self): Obscore, SIA2, SIA. """ constraints = [] - if self.space is not None: + if self.center is not None: constraints.append( - registry.Spatial(self.space, inclusive=self.inclusive)) + registry.Spatial(list(self.center)+[self.radius], + inclusive=self.inclusive)) if self.spectrum is not None: constraints.append( - registry.Spectral(self.spectrum, inclusive=self.inclusive)) + registry.Spectral(self.spectrum*u.m, + inclusive=self.inclusive)) if self.time is not None: constraints.append( registry.Temporal(self.time, inclusive=self.inclusive)) @@ -173,7 +194,7 @@ def ids(recs): # TODO: use futher heuristics to further cut down on dupes: # Use relationships. I think we should tell people to use - # IsDerivedFrom for SIA2 services built on top of TAP services. + # IsServiceFor for (say) SIA2 services built on top of TAP services. def _query_one_sia1(self, rec: Queriable): """runs our query against a SIA1 capability of rec. @@ -212,8 +233,8 @@ def _query_sia1(self): This will be a no-op without a space constraint due to limitations of SIA1. """ - if self.space is None: - self.log.append("SIA1 servies skipped do to missing space" + if self.center is None: + self.log.append("SIA1 service skipped do to missing space" " constraint") return @@ -227,9 +248,22 @@ def _query_one_sia2(self, rec: Queriable): """runs our query against a SIA2 capability of rec. """ svc = rec.res_rec.get_service("sia2") - self.results.extend( - ImageFound.from_obscore_recs( - svc.search(pos=self.space, band=self.spectrum, time=self.time))) + constraints = {} + if self.center is not None: + constraints["pos"] = self.center+(self.radius,) + if self.spectrum is not None: + constraints["band"] = self.spectrum + if self.time is not None: + constraints["time"] = time.Time(self.time, format="mjd") + + matches = list( + ImageFound.from_obscore_recs(svc.search(**constraints))) + if len(matches): + self.log.append(f"SIA2 service {rec}: {len(matches)} recs") + else: + self.log.append(f"SIA2 service {rec}: no matches") + + self.results.extend(matches) def _query_sia2(self): """runs the SIA2 part of our discovery. @@ -239,14 +273,15 @@ def _query_sia2(self): self._query_one_sia2(rec) except Exception as msg: self.log.append(f"SIA2 {rec.ivoid} skipped: {msg}") + raise def _query_one_obscore(self, rec: Queriable, where_clause:str): """runs our query against a Obscore capability of rec. """ svc = rec.res_rec.get_service("tap") + recs = svc.query("select * from ivoa.obscore"+where_clause) self.results.extend( - ImageFound.from_obscore_recs( - svc.query("select * from ivoa.obscore"+where_clause))) + ImageFound.from_obscore_recs(recs)) def _query_obscore(self): """runs the Obscore part of our discovery. @@ -255,15 +290,14 @@ def _query_obscore(self): # configurable. where_parts = ["dataproduct_type='image'"] # TODO: we'd need extra logic for inclusive here, too - if self.space: + if self.center is not None: where_parts.append("distance(s_ra, s_dec, {}, {}) < {}".format( - *self.space)) - if self.spectrum: - meters = self.spectrum.to(u.m, equivalancies=u.spectral()).value - where_parts.append(f"(em_min<={meters} AND em_max>={meters})") - if self.time: - mjd = self.time.mjd.value - where_parts.append(f"(t_min<={mjd} AND t_max>={mjd})") + self.center[0], self.center[1], self.radius)) + if self.spectrum is not None: + where_parts.append( + f"(em_min<={self.spectrum} AND em_max>={self.spectrum})") + if self.time is not None: + where_parts.append(f"(t_min<={self.time} AND t_max>={self.time})") where_clause = "WHERE "+(" AND ".join(where_parts)) @@ -320,4 +354,4 @@ def images_globally( discoverer.query_services() # TODO: We should un-dupe by image access URL # TODO: We could compute SODA cutout URLs here in addition. - return discoverer.result, discoverer.log + return discoverer.results, discoverer.log diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS new file mode 100644 index 00000000..497e723a --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS @@ -0,0 +1,28 @@ + + +ROSAT was an orbiting x-ray observatory active in the 1990s. +We provide a table of all photons observed during ROSAT's all-sky +survey (RASS) as well as images of both survey and pointed observations. + +For ROSAT data products, see +http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-survey{'siaarea0': <pgsphere PositionInterval Unknown 133.9490641653 10.95 +134.0509358347 11.05>, '_ra': 134.0, '_dec': 11.0, '_sra': 0.1, +'_sdec': 0.1, 'format0': frozenset({'image/fits', +'application/x-votable+xml;content=datalink', 'image/jpeg'})}Written by DaCHS 2.8.1 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceMetadata for ROSAT pointed observations and the ROSAT All Sky Survey +(RASS) images +Codes used here include: + +=== ============================================================== +im1 photon image in the broad band (0.1-2.4 keV) +im2 photon image in the hard band (0.4-2.4 keV) +im3 photon image in the soft band (0.1-0.4 keV) +ime image of the average photon energy +bk1 background image in the broad band (0.1-2.4 keV) +bk2 background image in the hard band (0.4-2.4 keV) +bk3 background image in the soft band (0.1-0.4 keV) +mex merged map of exposure times for the broad band (0.1-2.4 keV) +=== ==============================================================Access key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageROR sequence numberNumber of follow-up observation (0=first observation, NULL=mispointing)Type of data in the file (associated products available through datalink of by querying through seqno)Publisher dataset identifier (this lets you access datalink services and the like)Link to a datalink document for this dataset, this lets you access associate data)AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAANB2QGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtPhEKTkf/+mw+SqAaWYHPGD4BwBGVzv0pAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltMQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAYbVAYIY18QtAHkAmfLF9ZpfuAAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABJST1NBVCBNZWRpdW0gWC1SYXkAAAABbT4ObdT//buEPiqgGmC2e70+AcARlc79KQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAACmltYWdlL2ZpdHMAAKUnQGCGNfELQB5AJnyxfWaX7gAAADdST1NBVCBQU1BDQyBST1NBVCBTb2Z0IFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAC1JPU0FUIFBTUENDQOeG6tdfMa8AAAACAAAAAgAAAgAAAAIAAAAAAj+JmZmZmZmaP4mZmZmZmZoAAAAESUNSU0T6AABUQU4AAAACQHAIRD1GsmxAcAhEPUaybAAAAAJAYIYAAAAAAEAmgAAAAAAAAAAABL+JmZmZmZmaAAAAAAAAAAAAAAAAAAAAAD+JmZmZmZmaAAAAEFJPU0FUIFNvZnQgWC1SYXkAAAABbT41TOHhNKWsPkqgGlmBzxg+KqAaYLZ7vQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTMAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltZS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAUTpQGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtf/gAAAAAAAB/+AAAAAAAAH/4AAAAAAAAAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltZQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3o=
Datalink service for ROSAT images. This gives access to images in the +various bands, background maps, and other ancillary data. + +For more detailed information on the various data products, please +refer to http://www.xray.mpe.mpg.de/rosat/archive/docs/rdf.ps.gz
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS.meta new file mode 100644 index 0000000000000000000000000000000000000000..d376d94d6cf92849b54c922d55dcee7e5451cb8f GIT binary patch literal 1758 zcmZ`)QE%f!5H2)rLsPCT1q6bVqDoZlU1P@yE!Uz5l_VU!JCdjghlGU8+TO%_b!^wW zZktM#xEDmFePj6v{1@K&LwuV!Nl!ZRklmS`nVp?)zVUClzy4ib82@h7t}JjtM9OV9 z@~C?Lk6iI7@o2)8+)C(0O1a<$7fI@hG@)8sC!C&!oQ9kUc1at|73xp5_gdX5xomS0 zB~;0R8wCM%1&c!X6xsAA)Y@r^WOC7&{ca%eIzJZdHpC&Iii+0f*S#0Dz! zO{d+hS=BF%@)wo5Wf|q2?&;6XTG_C6PFua^S+`m5)!HwcXD?1V-5spo)+)+>*Iyd< zl%Mwtd%9s(Q=nfW0~Acj)gQHRG7+A{qnB;dG7gZyrS(OeZj)?dQW4vPF$D9;$9c7pG-9K9^4$sL{=XdC@u3)Y_P#GgED5u<-iW=ov}o0Ik?@ zgkBse`9Py$Oq^c9L~b=`pP-K>UY&_qMp86HNCkHZ+WQYQSKqB19UiDV@Eu#Ld}I@D z&n#MU%?G|&k`yzEQI2-Op!&h(-0hGeWsa#8$QmCL;mK;o!pq8WWk;< z$j|3WPKC`vu!sb>EePTkdm``?`L?XiMK{c0jQLrvvajrqxu$=&` zpjUIc?7zc&l0mHBBmG +Definition and support code for the ObsCore data model and table.{'pos0': <pgsphere Circle Unknown 134. 11. 0.1>, 'BAND0': +2.0664033072200047e-09}Written by DaCHS 2.8.1 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. +The calib_level flag takes the following values: + +=== =========================================================== + 0 Raw Instrumental data requiring instrument-specific tools + 1 Instrumental data processable with standard tools + 2 Calibrated, science-ready data without instrument signature + 3 Enhanced data products (e.g., mosaics) +=== ===========================================================High level scientific classification of the data product, taken from an enumerationAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lamdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.AAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6AAAAPlJPU0FUIFBTUENDIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9iazEuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAADLAAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAVgAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTEuZml0cy5negAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAANAAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+SqAaWYHPGH/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQyBST1NBVCBNZWRpdW0gWC1SYXkgMTk5MC0xMC0xOSAwODowNzo1MS41MDAwMTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAAAAAAHpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABgAAAAAAAAAAEBghjXxC0AeQCZ8sX1ml+5AGZmZmZmZmgAAAH5Qb2x5Z29uIElDUlMgMTM1LjQwNDkzMTgyNTkgOC4wNDY4MDY3ODQ4IDEzNS40NzY5MjI2MzE5IDE0LjQxNzQ0MTgzODggMTI4Ljg5ODUwNTQ1MjIgMTQuNDE3NDQ3NzcxNSAxMjguOTcwNDg2OTI5MiA4LjA0NjgxMDA0NzNARoAAAAAAAEDnhurXXzGvQOeG6tdfMa9/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENDAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0BGgAAAAAAAAAAAAAAAAIdodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWUAAAAFaW1hZ2UAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAADwAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazEuZml0cy5negAAAD5ST1NBVCBQU1BDQiBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkzLTA0LTI1IDE3OjI3OjQzLjEyOTk5NgAAAFtpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6AAAAAAAAAHJodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAbAAAAAAAAAABAYJtFRGOCNEAnp9uUMZwPQAERERoDt0UAAAB+UG9seWdvbiBJQ1JTIDEzMy45MzM0MTYyMTA0IDEwLjc2MzU5MDAwMTEgMTMzLjk0MTg3OTk4OTIgMTIuODkyMTI4MzMxOSAxMzEuNzU4Mjc0Mzg1IDEyLjg5MjEyODkyMiAxMzEuNzY2NzM3MDYwNyAxMC43NjM1OTA0OTEyQC4AACGN70FA5/nXSFskwkDn+ddIWyTCf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQgAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ALgAAIY3vQQAAAAAAAAB/aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABHcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAA5Uk9TQVQgUFNQQ0IgUk9TQVQgTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABUAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQiBST1NBVCBNZWRpdW0gWC1SYXkgMTk5My0wNC0yNSAxNzoyNzo0My4xMjk5OTYAAABbaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAAAAAAAByaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAIAAAAAAAAAAAQGCbRURjgjRAJ6fblDGcD0ABEREaA7dFAAAAflBvbHlnb24gSUNSUyAxMzMuOTMzNDE2MjEwNCAxMC43NjM1OTAwMDExIDEzMy45NDE4Nzk5ODkyIDEyLjg5MjEyODMzMTkgMTMxLjc1ODI3NDM4NSAxMi44OTIxMjg5MjIgMTMxLjc2NjczNzA2MDcgMTAuNzYzNTkwNDkxMkAuAAAhje9BQOf510hbJMJA5/nXSFskwn/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0IAAAAAAAACAAAAAAAAAAIA////////////////////////////////QC4AACGN70EAAAAAAAAAf2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWU=
A datalink service accompanying obscore. This will forward to data +collection-specific datalink services if they exist or return +extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta new file mode 100644 index 0000000000000000000000000000000000000000..197c6d2c1238520fc4d95035110c4180108bee82 GIT binary patch literal 1853 zcmb7FT~Fgi6h$QvMCbxVTeWIevQSmQLLA58W1&J7P3U$%8X}&m>O5R#a;95YN4H@15~I=Uo3>`ok?x4SqLzO;v=XG8e>8 z0;XU5rOF|r0n3C|D;ay8Ga-d7WS09f&zSKxsbJ4y!D7KBzho`$OZ~fEf2(h_nk7Oe z8PlrbCsD+F$&(m4mE#O0Sulz{!MV#aqp|3+tjc1X&Es>emd{4Mqp`2-hk1O#0{sih z3zl8742#oZ@u)?c-<;N5`-xq*(`Gw}<45=$1#s_du8TWA*M*}(jmrfI}|YF?~%UA;^s^&+-$ z-HS}_$|yJBB27$xlGt>tDABs>U8Pb|KkVVCFRU()SWJ8DU==;iBWc^Hyo!>!@Km|L zL92%&L`X03FYK{@g`5nbI`&?n>76XO?vF58Q*&e-xHu|c_W*YUXcjveODV7^DooO5 zdrXE&pw;x#qci;HS)|o(p_J)MngzHlzAtQ%&{=b%ZIo};r`&3|W%!=dpc?SFq1BPlv2ot@ zws*QauniaL4v5j|~4K9sg9J`ha z{6upQ^qgiBB+DdCK-#`m4-9r>I}mQHG?@ZlftLa!LMLp*LU}J zw)HIr1D17Xk5ECz5pA^)0_Nh9F2df&*uZcgLDHi -ADQL query translated to local SQL (for debugging)ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, content_type, source_format, source_value, region_of_regard, waveband">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta new file mode 100644 index 0000000000000000000000000000000000000000..00a8d1bcb7c6391c906d73975e36f8fb01a20e10 GIT binary patch literal 3019 zcmdT`-EI>{6pl(lQbGwSYNe_mxfel!#cS`H{1}M~j#h_^+Kh`hy2aVskO?VtA$e%YkTZp?Qo#;A!93weXUq;9OUA#&_uj|v z;^-<7(&sFW)-B(4nI#?H1J8PkLnO0jv~B3!l$?5^&v>4B(Cv7GINI#aaJ4yZ)f$H0 zDYN5WAYL#&W*nPNwz+datIs+GQ{UH(oSZm9GW!+l70jYu(u;~`*`^W(EgvMyojP|O z?YthGzeVBqUvIWv;5eX zwC6JIY~+GB6uoFQb6OmIHFF;s`PQjE$KN9D)UU1H8+hoL`)AXc1Gl3!GAG=a3D8G~ zjSD|+9CH>>I5Ly4V7oeEa_HN*=W(mkjiW0ecjM^xP|Dy@p}^TdAHZ1M=YxWzK|xGC zD;|C}TuH(d zit}p9iA~CYi`_5WS0~pHCNE7e00`0oIAtuzQy00Z2ye{d=`wF1hd|6C+Q<;g#>1UG zMS6MYzxy!slgT9C_xUIfPbV3iq^L@PHPn)S>ZoG5IS=6+wVB0ER1>1-lrN&VN&+9* zHHDEXa(c@21|-p~1JY?c{mg6s>_H>#M}{)jpr5Z`8qOcDt_RGrgzRIWqA*V(ZrK0G;(ZZ1wTVc#!B zw--pkByl|S4eCOh>*8kT(U%{d2NY3KqL_t_LjvwgAKe7rTv1NJdSxPniq}ojb5UB% z&MX)4J>aP8`jZQ|X0%K^e-c0c-F)5n#A7md5Xw_iW*)Ec#FcdJ-&#=c{3nN{i!+K=N(6hGfN2+6sPjV(VwHeYDgu!r z#?%cn3kDEP{66~0fbzuN2_3T@^^!gAp=r1Y8a7AoC3G;@GWV;kN~6}P*05ETClKJ& zoGo)N`N~R{+LbEl7fiL6Elsdsj!EgXN=I9W5DDAAsl+7mY}iUt_kNPj3o<@VspHB1 z+^wIaaxURNDCB;c8=tOFNf3x)z1=#(!Z{{PngoEFmF`Kq($E^UdRJ?mbZc$xdF!yL zfeKxM_8ixd)63~_E5`fOVwaPtOt+b&j(a(skQNarZB+ip5Tdj5g!0w1TDt}gWMry_ zoT&z(ZIup^JT&VUE@aj*?CFu3mRn|h>tPWIo>$4Vr&XEO@Jz?RMvt{li;X_T7VWF1jfVfmmwbkra4x1eyj#^dx z@2VQ89=59uRbEEvp@I!V{TFpCi5LKuk7kP*oMA2qF6+BSskl?#FP6&cx6ks%p7x~H zeO0S9H4&svLq$_A6JzEmrixw}`Lx|SIo6)M#unH5f44C;5HLf9dU&oO4+Fe4S^Q%x zq8miDbqrJWMD@M68LFwAgd4BNX0)!_8o^6S3WBi@z;${$VDLxl$7*defoY4;yd5p8 zu>-P;uc$cseDRQqmf~SJ3}yTtvx&S-4IuvHIc kbcF2+u^3k@YijPDsW(LOG>bNfN?1&T?A0BghrLk$2QphCzW@LL literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY new file mode 100644 index 00000000..e7a20f7a --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY @@ -0,0 +1,25 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAB2NhdGFsb2cAAAAHYmliY29kZQAAABMAMgAwADAAMABJAEEAVQBDAC4ANwA0ADMAMgBSAC4ALgAuADEAVn/AAAAAAAAFeC1yYXkAAAA0aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL3NpYXAueG1sPwAAABZpdm86Ly9pdm9hLm5ldC9zdGQvc2lhAAAADHZzOnBhcmFtaHR0cAAAAANzdGQ=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta similarity index 56% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org--%9TAGj9w.meta rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta index c101d81541ca619c69dc659d854e9a10dd89f26b..a8da7d053d0f0513e019870def4d2690285e1b2a 100644 GIT binary patch delta 148 zcmZ1~epHO5fn}=IM3zg;7J7ygZ>mbV6=muu7#S$|Czk*zBVz?aLn~8DD?^LT;*7eC z!p7R^X-TGLX=bK+DIjS>1Ea~|OnaD(jf^KtGb(MiU_Qtw)01tKTAGyMQ9C6g#S6me uVM)qQshkp_y;+pimU(gw#|Cy2RU>C@L&M3&oYssMlk+)^HecsF#|Qu@Ju46Z delta 206 zcmX>qwp5&@fo1Bfi7c0x&Gn2Y-c*$gDNWT;Ff>r`PcBg~GB7e$Ff_6+bqtg z%P4H5ot|W7X>4X}p_c-ZHZ(At9L}_d*~HLtvNWU8W(($nj51RkRZ~loGCXRhWTbdO zI6W*$`6-oCBDyz=vf46pl%(bsFmL__Z+D@(^;jXTJ+9jE}sqw`niA5z~6(H{BT+SPe0NN}(Jpcdz diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW new file mode 100644 index 00000000..afc3d06d --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW @@ -0,0 +1,25 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAAAAAAAAAAAAAAH/AAAAAAAAAAAAARGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9zaWFwMi54bWw/AAAAIGl2bzovL2l2b2EubmV0L3N0ZC9zaWEjcXVlcnktMi4wAAAADHZzOnBhcmFtaHR0cAAAAANzdGQ=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta new file mode 100644 index 0000000000000000000000000000000000000000..3a7bd052a9a85b0742dba34b3585c39f1522a591 GIT binary patch literal 2895 zcmdT`QIFF`5I&VV?#fY)D{7^xAf*q74osZb=^Ym&9zv3XgOD6a4$4Ed+Sr@eoMW5a zb#keMR9>o{hkQ%EW! zL9D=L$+N%Xb%#-#agoF~IC~p0A%!j^k1QE+rnq$~*pV-oFI?$PSi`ks@<(##eey1e zFB2gH&XRc33OtWl(hYp*Y<4(IGJ7uD#lG8;Q(p`jFESr{yZ$JNxBGKmbHQ7;oX9_A zcJdp{3&tmmW6{eOw;Htmq*pTa1KlXdsVgM2U$H^SEbA4$taMgwD&f#-BYoXEVrz9@c4OO$zQbsUou}7r`LxZ;);l*UsP#B6Q4yv)Md=yYU8D2yV>{=wsx@ zLman`ISVNQnOj(@T^=*(1UAlj-0Ag`_)^5ZB);iL89peLI2-9BII9PIRFX6-iJ5OD z&KJ&Fnl@*{*}S82awS55i*$tJC-IdNMbt9lAe_DIlni}Ox7ozFU(rUx!QTFGAGC_1 zQAS9QXK=wURdmD9&BAWW^`o;pDx_P~vREiDBzmisah7S`9{u8m_X;)}dPvm0!hkEy z%b6w?nF0=Ww{%y1xq>wL8NfgwNlW6Cv9L%zU{eWRo9EMG{zy7t%rn}`8LLL6QcIQd;yMWfplb#v zRp#_e=?z5U8x1z3ktZ{)<4i0sJD|pAQdks#{T&D#T4r^BFF8jAV`-GDgbK2dXvbF_ z*JinsCd9r%eWQwr9gL~#gYkXN$Ssk`N7cDQS79AHe4Bsv#fM+cWxv^&}@y#Vu zFiBh=eS><~>@w^Z4rzzlRiAQl^-NjzdBo$N=30(OgqO!TZuw2$iqvWZ~^cxe*Cc3c+t8Ie)sjmUbEG#_jk%QcM`bvj#<~x4~gm$YAu|AOXAaUN~K?1>7_&t zK;p3p^X7Us6Bc(v)kiWGIw4@h2;ig`7H1T#lnC}VC9^KH+%AYXgcSg(R01MnOsE&- z9*kg`1Vi+b5#_1BQ#xS->Zfa*L(^~)G;EIEOXz5{V;}Z083r;4d)q2{}ghVKNYaYS;QF-C9d)H4pn*=cM24YEL^yZ4FZB z5_I5tuAF^b4yR&#NGQ;{|x92)6<>Jj}tIbHQ*`-#04dz3M@^QdPeLRy6Kw zkDC2g&1PE@VRk@N73DH@X2D{r@RXB}yPcC`?a^y2|M#s#HD$~(p)P+L0APsw9!q{s zM0|~?){23qu8D!4v?Dbc(XA{8H@J4ZsagxcZAJ=$(F?+J2Rdlz$D7CM-DLt3594t+ zURA9hVi#{RN&MyVG83;PPUJ)~d5`%(-ewLF>5f?dW_vyt&<$;uBS`|hb&`&?nHrj^ n4>CH&a*bGwE0qm3d(PAxPp?Pu7O`;kMMutWzR7tsi1dE|v(fsg literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 217e2e90..f163ae27 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -18,8 +18,17 @@ def _all_constraint_responses(requests_mock): requests_mock.add_matcher(matcher) -def test_with_all_constraints(_all_constraint_responses): - res = discover.images_globally( - space=(132, 14, 0.1), - time=time.Time(58794.9, format="mjd"), +def test_cone_and_spectral_point(_all_constraint_responses): + images, logs = discover.images_globally( + space=(134, 11, 0.1), spectrum=600*u.eV) + + assert ("SIA2 service : 8 recs" + in logs) + + assert len(images) == 8 + assert images[0].obs_collection == "RASS" + + # expected failure: the rosat SIA1 record should be filtered out + # by its relationship to the sitewide SIA2 + assert len(logs) == 1 From 558b8a4a307634cff983878eb36285bc45d22ecd Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 24 Oct 2023 10:48:10 +0200 Subject: [PATCH 07/38] Making SIA1 discovery roughly work. Also, new method set_services on _ImageDiscoverer to pass in a custom resource list (for now, for testability) Also, exposing RegistryResource and RegistryResults in the registry API; they're really central in using the stuff, and we'll need them in type annotations a lot. --- docs/index.rst | 1 + pyvo/discover/image.py | 97 ++++++++++++------ ...siap.xml_intersect=['over-VQN20JIanSxbrIwk | 17 +++ ...xml_intersect=['over-VQN20JIanSxbrIwk.meta | Bin 0 -> 1761 bytes ...org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ | 21 ++++ ...ync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta | Bin 0 -> 2634 bytes pyvo/discover/tests/test_imagediscovery.py | 31 ++++++ pyvo/registry/regtap.py | 3 + 8 files changed, 141 insertions(+), 29 deletions(-) create mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk create mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk.meta create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta diff --git a/docs/index.rst b/docs/index.rst index 567f0fc0..72ffd39e 100644 --- a/docs/index.rst +++ b/docs/index.rst @@ -138,3 +138,4 @@ Using ``pyvo`` mivot/index utils/index utils/prototypes + utils/testing diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 6acb6e0a..6c2be64a 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -17,6 +17,7 @@ from astropy.coordinates import SkyCoord from ..dam import obscore +from .. import dal from .. import registry @@ -84,22 +85,23 @@ def from_sia1_recs(cls, sia1_result, filter_func): for rec in sia1_result: if not filter_func(rec): continue - mapped = { "dataproduct_type": "image" if rec.naxes == 2 else "cube", "access_url": rec.acref, - "bandpass_hilimit": rec.em_max.to(u.m).value, - "bandpass_lolimit": rec.em_min.to(u.m).value, + "em_max": rec.bandpass_hilimit is not None + and rec.bandpass_hilimit.to(u.m).value, + "em_min": rec.bandpass_lolimit is not None + and rec.bandpass_lolimit.to(u.m).value, # Sigh. Try to guess exposure time? - "t_min": rec.dateobs, - "t_max": rec.dateobs, + "t_min": rec.dateobs.mjd, + "t_max": rec.dateobs.mjd, "access_estsize": rec.filesize/1024, "access_format": rec.format, "instrument_name": rec.instr, - "s_xsel1": rec.naxis[0], - "s_xsel2": rec.naxis[1], - "s_ra": rec.pos[0], - "s_dec": rec.pos[1], + "s_xel1": rec.naxis[0].to(u.pix).value, + "s_xel2": rec.naxis[1].to(u.pix).value, + "s_ra": rec.pos.icrs.ra.to(u.deg).value, + "s_dec": rec.pos.icrs.dec.to(u.deg).value, "obs_title": rec.title, # TODO: do more (s_resgion!) on the basis of the WCS parts } @@ -120,12 +122,17 @@ class _ImageDiscoverer: diagnostics. This probably should not be considered API but rather as an implementation detail of discover_images. - For now, we expose several methods to be called in succession - (see discover_images); that's because we *may* want to make - this API after all and admit user manipulation of our state - in between the larger steps. + The normal usage is do call discover_services(), which will locate + all VO services that may have relevant data. Alternatively, call + set_services(registry_results) with some result of a registry.search() + call. _ImageDiscoverer will then pick capabilities it can use out + of the resource records. Records without usable capabilities are + silently ignored. + + Then call query_services to execute the discovery query on these + services. - See discover_images for a discussion of its constructor parameters. + See images_globally for a discussion of its constructor parameters. """ # Constraint defaults # a float in metres @@ -137,7 +144,8 @@ class _ImageDiscoverer: # a radius as a float in degrees radius = None - def __init__(self, space, spectrum, time, inclusive): + def __init__(self, + space=None, spectrum=None, time=None, inclusive=False): if space: self.center = (space[0], space[1]) self.radius = space[2] @@ -151,8 +159,24 @@ def __init__(self, space, spectrum, time, inclusive): self.inclusive = inclusive self.results: List[obscore.ObsCoreMetadata] = [] self.log: List[str] = [] + self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] + + def _purge_redundant_services(self): + """removes services querying data already covered by more capable + services from our current services lists. + """ + def ids(recs): + return set(r.ivoid for r in recs) + + self.sia1_recs = _clean_for(self.sia1_recs, + ids(self.sia2_recs)|ids(self.obscore_recs)) + self.sia2_recs = _clean_for(self.sia2_recs, ids(self.obscore_recs)) + + # TODO: use futher heuristics to further cut down on dupes: + # Use relationships. I think we should tell people to use + # IsServiceFor for (say) SIA2 services built on top of TAP services. - def collect_services(self): + def discover_services(self): """fills the X_recs attributes with resources declaring coverage for our constraints. @@ -182,19 +206,27 @@ def collect_services(self): self.obscore_recs = [Queriable(r) for r in registry.search( registry.Datamodel("obscore"), *constraints)] - # Now remove resources presumably operating on the same underlying - # data collection. First, we deselect by ivoid, where a more powerful - # interface is available - def ids(recs): - return set(r.ivoid for r in recs) + self._purge_redundant_services() - self.sia1_recs = _clean_for(self.sia1_recs, - ids(self.sia2_recs)|ids(self.obscore_recs)) - self.sia2_recs = _clean_for(self.sia2_recs, ids(self.obscore_recs)) + def set_services(self, + registry_results: registry.RegistryResults) -> None: + """as an alternative to discover_services, this sets the services + to be queried to the result of a custom registry query. - # TODO: use futher heuristics to further cut down on dupes: - # Use relationships. I think we should tell people to use - # IsServiceFor for (say) SIA2 services built on top of TAP services. + This will pick the "most capabable" interface from each record + and ignore records without image discovery capabilities. + """ + for rsc in registry_results: + if "tap" in rsc.access_modes(): + # TODO: we ought to ensure there's an obscore + # table on this; but then: let's rather fix obscore + # discovery + self.obscore_recs.append(Queriable(rsc)) + elif "sia2" in rsc.access_modes(): + self.sia2_recs.append(Queriable(rsc)) + elif "sia" in rsc.access_modes(): + self.sia1_recs.append(Queriable(rsc)) + # else ignore this record def _query_one_sia1(self, rec: Queriable): """runs our query against a SIA1 capability of rec. @@ -216,7 +248,7 @@ def non_spatial_filter(sia1_rec): # metadata. TODO: require time to be an interval and # then replace check for dateobs to be within that interval. if self.time and not self.inclusive and sia1_rec.dateobs: - if not self.time-1 + The Bochum Galactic Disk Survey is an ongoing project to monitor the +stellar content of the Galactic disk in a 6 degree wide stripe +centered on the Galactic plane. The data has been recorded since +mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at +the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean +Atacama desert. It contains measurements of about 2x10^7 stars over +more than seven years. Additionally, intermittent measurements in +Johnson UVB and Sloan z have been recorded as well.{'siaarea0': <pgsphere PositionInterval Unknown 115.9428322966 -29.05 +116.0571677034 -28.95>, '_ra': 116.0, '_dec': -29.0, '_sra': 0.1, +'_sdec': 0.1, 'format0': frozenset({'image/fits', +'application/x-votable+xml;content=datalink', 'image/jpeg'})}Written by DaCHS 2.8.1 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataLegal conditions applicable to (parts of) the data containedContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceAccess key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageSurvey field observed.Effective exposure time (sum of exposure times of all images contributing here).Dataset identifier assigned by the publisherAAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBiJAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA2jAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCzWgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfrgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBe+gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEOgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCBFAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDElAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHvgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB3PAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHaAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+FwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD+DwEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgCAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjI3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJyiUsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjIyOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5ICp6IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA9ZwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBT5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEWfgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDInwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAAaAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/5BgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/98gEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2CQEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDxOgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDzKQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/k/AEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDPegEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIxVDA0OjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXMCp8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDTKwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjEzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaPXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC95gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjI0OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI3wEkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjuQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBm4wEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIxVDA0OjA1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXKJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjMxOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLC8HMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwBwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCrngEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWhgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFeQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCRxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCOnQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCenAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1dgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1egEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2vQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUkwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqNgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCN6QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6DAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCiTQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAsAAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjEzOjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaN18wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjBQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjI0OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI2O+wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKDwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjU4OjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUwi5EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkEwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjMzOjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL9uXUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjMyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLmlvIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjM3OjE0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSrAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBd7AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRRAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB2tQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/BIAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB7+wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBGBAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSfwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBxQgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkbQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBlqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6OQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHkQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjU4OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUyD+4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAH9wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBBGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhcAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCt5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjM0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJMJe0IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCoGgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjMzOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL/PdIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCREwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjMyOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCebwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjM3OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNQBhEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCI/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCpQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjU2OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZUE7i0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDK6AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjUzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRTIP7cAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgNQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjMwOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHo1niawAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBHxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjMxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLDsqIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOmQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDeawEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA4VDA0OjA1OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBXRWeIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfVAEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBTMwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCLGQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDWKAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDsqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZUgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBLSgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUbgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBR+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUyAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBsKQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjMgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9WEwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUwAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDIGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+cQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAKxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1HAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5IDCLkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKNAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjI3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJy6mIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBecwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBc3gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBdvwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+d+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB/UgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZAAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjI1OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI5pbwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjE1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FaQ4IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEZwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIxVDAzOjU3OjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUi5FAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRDwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjA2OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCsrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjE3OjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjUwOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRSBU9EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCkPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjI2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJJXOskAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaZAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjI2OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJQZykAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHlQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCQuQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC+bQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCKCwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3OAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5hQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo0gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4qAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5WAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAU+QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE2VDA2OjU1OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCS1QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0EgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqYwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBA6wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDC0gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/n+QEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAyOjQ2OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7UAYQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgYgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZLQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB11AEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDMfQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI0VDAxOjMxOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4goM5QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaCgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDN5QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBORwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBNDAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRngEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSJQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBMKwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBL0QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9IAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZ4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjI0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQl7QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBifgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcKgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfgQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjIzOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHoy/hqMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBJiAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDA4wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC66QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDLAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjI0OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQNp0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCXlAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCSwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCx8gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDjKgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDnjwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjM0OjE4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP23LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBABdgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/7fAEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/6QQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBACKgEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/9mAEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDS0QEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEJTwEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD49gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwuwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI0VDAxOjMxOjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4golKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo/wEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBunwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1pwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfJwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBf2wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCCTwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBpWQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBtvgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCEawEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBg6QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmtgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBIpwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE2VDA2OjU1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTlEpUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBx9gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBByIwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhQwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgvAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE1LTAzLTIwVDAyOjQ2OjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7ToG0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+VLgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBvrQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBPVQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB8ggEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmXAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjM0OjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP22zY8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKwwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjI5OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKdZIEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBXmAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjI1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjUwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRR/z3QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBaOwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjE3OjI2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGMtIcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjA2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXlc60AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmLwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIxVDAzOjU3OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUgncYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBYeQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjE1OjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FZgVQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBOzgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGVgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCh8wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGgwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjQ2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRQc0t4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3CwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjQ4OjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZRU9D4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCG4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCbnwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjI5OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKeJq8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdNAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjI1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI6Z+sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6
This service lets you access cutouts from BGDS images and retrieve +scaled versions.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk.meta b/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk.meta new file mode 100644 index 0000000000000000000000000000000000000000..c204a5a364039232899b642d99ea70ffbfb20ba0 GIT binary patch literal 1761 zcmZ`)ZBHXN5T+%Nl+Xi8TeWIWija!nj(C#=j+ZK`XcAqyyCxAyuhK~;*Xwn%J~q3{ z+6x2;seGx5@*N85M1(0*5Fj?zx4KNap^^9LuhtT~skXIhRPdP_B^sw`RC0Z{7+(EE6^Gz2ZS~y=_QaA(XO6J}ASLlQA+Y!nMH-k9JBf>-$hfJ0&MJo{M8on2a4D zNl&aNW@iZsAsClGEP(&n;+(OlOngvIMsES67oKyYt<@<#Q)n&YMbuNH7bKoBl*dsB z#W>RHk)Z{Ro!)_oT5qsEfkGO4b;f3yN}(bGCIux>-+w}N^{IXIY+v7l;9**=9AP5x z)S{)9Js>!{qzz`DLOTG_V>cWU9sux724saTru|mpfc%C;QV-fzOBFGw2!r0Fz|dP@;d2MU8vIqUW5%pjI%2j}e}Ji}ZcsB +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL2JnZHMvcS9zaWEAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAIYmdkcyBzaWEAAAApAEIAbwBjAGgAdQBtACAARwBhAGwAYQBjAHQAaQBjACAARABpAHMAawAgAFMAdQByAHYAZQB5ACAAKABCAEcARABTACkAIABpAG0AYQBnAGUAcwAAAAhyZXNlYXJjaAAAAgsAVABoAGUAIABCAG8AYwBoAHUAbQAgAEcAYQBsAGEAYwB0AGkAYwAgAEQAaQBzAGsAIABTAHUAcgB2AGUAeQAgAGkAcwAgAGEAbgAgAG8AbgBnAG8AaQBuAGcAIABwAHIAbwBqAGUAYwB0ACAAdABvACAAbQBvAG4AaQB0AG8AcgAgAHQAaABlAAoAcwB0AGUAbABsAGEAcgAgAGMAbwBuAHQAZQBuAHQAIABvAGYAIAB0AGgAZQAgAEcAYQBsAGEAYwB0AGkAYwAgAGQAaQBzAGsAIABpAG4AIABhACAANgAgAGQAZQBnAHIAZQBlACAAdwBpAGQAZQAgAHMAdAByAGkAcABlAAoAYwBlAG4AdABlAHIAZQBkACAAbwBuACAAdABoAGUAIABHAGEAbABhAGMAdABpAGMAIABwAGwAYQBuAGUALgAgAFQAaABlACAAZABhAHQAYQAgAGgAYQBzACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAHMAaQBuAGMAZQAKAG0AaQBkAC0AMgAwADEAMAAgAGkAbgAgAFMAbABvAGEAbgAgAHIAIABhAG4AZAAgAGkAIABzAGkAbQB1AGwAdABhAG4AZQBvAHUAcwBsAHkAIAB3AGkAdABoACAAdABoAGUAIABSAG8AQgBvAFQAVAAgAFQAZQBsAGUAYwBzAG8AcABlACAAYQB0AAoAdABoAGUAIABVAG4AaQB2AGUAcgBzAGkAdABhAGUAdABzAHMAdABlAHIAbgB3AGEAcgB0AGUAIABCAG8AYwBoAHUAbQAgAG4AZQBhAHIAIABDAGUAcgByAG8AIABBAHIAbQBhAHoAbwBuAGUAcwAgAGkAbgAgAHQAaABlACAAQwBoAGkAbABlAGEAbgAKAEEAdABhAGMAYQBtAGEAIABkAGUAcwBlAHIAdAAuACAASQB0ACAAYwBvAG4AdABhAGkAbgBzACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABvAGYAIABhAGIAbwB1AHQAIAAyAHgAMQAwAF4ANwAgAHMAdABhAHIAcwAgAG8AdgBlAHIACgBtAG8AcgBlACAAdABoAGEAbgAgAHMAZQB2AGUAbgAgAHkAZQBhAHIAcwAuACAAQQBkAGQAaQB0AGkAbwBuAGEAbABsAHkALAAgAGkAbgB0AGUAcgBtAGkAdAB0AGUAbgB0ACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABpAG4ACgBKAG8AaABuAHMAbwBuACAAVQBWAEIAIABhAG4AZAAgAFMAbABvAGEAbgAgAHoAIABoAGEAdgBlACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAGEAcwAgAHcAZQBsAGwALgAAAC9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvaW5mbwAAACwASABhAGMAawBzAHQAZQBpAG4ALAAgAE0ALgA7ACAASABhAGEAcwAsACAATQAuADsAIABGAGUAaQBuACwAIABDAC4AOwAgAEMAaABpAG4AaQAsACAAUgAuAAAABnN1cnZleQAAAAdiaWJjb2RlAAAAEwAyADAAMQA1AEEATgAuAC4ALgAuADMAMwA2AC4ALgA1ADkAMABIf8AAAAAAAAdvcHRpY2FsAAAB6Wh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsbWV0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsZ2V0Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL3NpYS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9CR0RTOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9iZ2RzL3Evc2lhL3NpYXAueG1sPwAAAURpdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NvZGEjc3luYy0xLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eDo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAADKdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnI6d2ViYnJvd3Nlcjo6OnB5IFZPIHNlcDo6OnZzOnBhcmFtaHR0cAAAAH5zdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjpzdGQ=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta new file mode 100644 index 0000000000000000000000000000000000000000..fb7279b481268306c214a413820dd37e7034570b GIT binary patch literal 2634 zcmdT`TW=Fb6po4^X+jApYNe_mxeq}Ji`VuVNP>ha*KxQR+t?12hiWw59q%q#?=Ca5 zc3cSwUaCggw{HJa|3&{wzu8^e;RRaWYFXMjXU=8jT)s2!3V;5%zLNglCOh$lkW@y3 zn1RKTr+>w(4x<+1B8jhY_9kLN3SCGZnKI%`aT`>y$G%{`aHTt8hps7;Ka$<|$=f8p zM1%}DOX3YP@H}QpH}Ije(cv)3thsCtezzp2z8EoHVm^GkzMaHdgE_Cc;H{cYd;;}gcQ=;w{ltU6<}LeIH@sc6*vLboZWo7K zXT)MH_H-q_ zzGMm}iR%M5s0VMJhnt09_I`vkw-)Lf~I!_?M*>Sdw zz4U*ee5qBfp8dm__M)Q+7A`oMoL28^OA{hh`;<#eBHzMUNfzGE@_Ek2zjNyPaOt)M5KrPSmvcN` zNu0=uWbz)+NZw=zBGMhR0L=Cr5&;C3%P}$qc&j8u^qHC$3IZ4%V|kI7j4PEj1-qwe XgrzToc$1iT^#P3XM_+Ol4I}*@y?e2e literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index f163ae27..3ec50f16 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -8,7 +8,10 @@ from astropy import time from astropy import units as u +from pyvo import dal from pyvo import discover +from pyvo import registry +from pyvo.discover import image from pyvo.utils.testing import LearnableRequestMocker @@ -18,6 +21,34 @@ def _all_constraint_responses(requests_mock): requests_mock.add_matcher(matcher) +@pytest.fixture +def _sia1_responses(requests_mock): + matcher = LearnableRequestMocker("sia1-responses") + requests_mock.add_matcher(matcher) + + +def test_no_services_selected(): + with pytest.raises(dal.DALQueryError) as excinfo: + image._ImageDiscoverer().query_services() + assert "No services to query." in str(excinfo.value) + + +def test_single_sia1(_sia1_responses): + sia_svc = registry.search(registry.Ivoid("ivo://org.gavo.dc/bgds/q/sia")) + discoverer = image._ImageDiscoverer( + space=(116, -29, 0.1), + time=time.Time(56383.105520834, format="mjd")) + discoverer.set_services(sia_svc) + discoverer.query_services() + im = discoverer.results[0] + assert im.s_xel1 == 10800. + assert isinstance(im.em_min, float) + assert abs(im.s_dec+29)<2 + assert im.instrument_name == 'Robotic Bochum Twin Telescope (RoBoTT)' + assert "BGDS GDS_" in im.obs_title + assert "dc.zah.uni-heidelberg.de/getproduct/bgds/data" in im.access_url + + def test_cone_and_spectral_point(_all_constraint_responses): images, logs = discover.images_globally( space=(134, 11, 0.1), diff --git a/pyvo/registry/regtap.py b/pyvo/registry/regtap.py index 20461305..3a8d38e6 100644 --- a/pyvo/registry/regtap.py +++ b/pyvo/registry/regtap.py @@ -238,6 +238,9 @@ def search(*constraints: rtcons.Constraint, ~pyvo.registry.RegistryResults` a container holding a table of matching resource (e.g. services) + See Also + -------- + RegistryResults """ service = get_RegTAP_service() query = RegistryQuery( From 4f4e34e13bb049c6dca0033986aa4fd2a82bd65e Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Wed, 25 Oct 2023 16:45:04 -0400 Subject: [PATCH 08/38] In global discovery, now removing services that are served-by some other service. Also, improving discovery logging a bit Also, adding an admonition to not use utils.testing outside of pyVO. (which attemtps to address https://github.com/astropy/pyvo/pull/470#pullrequestreview-1695147699) Also, removing stale test inputs for global discovery. --- docs/utils/testing.rst | 4 + pyvo/discover/__init__.py | 2 +- pyvo/discover/image.py | 115 ++++++++++++++---- ...siap.xml_intersect=['over-KwbduA7iAm3yI+JS | 28 ----- ...xml_intersect=['over-KwbduA7iAm3yI+JS.meta | Bin 1758 -> 0 bytes ...iap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ | 18 --- ...xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta | Bin 1853 -> 0 bytes ...org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt% | 26 ---- ...ync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta | Bin 3019 -> 0 bytes ...org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY | 25 ---- ...ync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta | Bin 2885 -> 0 bytes ...org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW | 25 ---- ...ync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta | Bin 2895 -> 0 bytes ...siap.xml_intersect=['over-VQN20JIanSxbrIwk | 17 --- ...xml_intersect=['over-VQN20JIanSxbrIwk.meta | Bin 1761 -> 0 bytes ...org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ | 21 ---- ...ync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta | Bin 2634 -> 0 bytes pyvo/discover/tests/test_imagediscovery.py | 24 +++- pyvo/registry/rtcons.py | 13 +- 19 files changed, 120 insertions(+), 198 deletions(-) delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt% delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta delete mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk delete mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk.meta delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta diff --git a/docs/utils/testing.rst b/docs/utils/testing.rst index dbb3f8ae..0f3e83cb 100644 --- a/docs/utils/testing.rst +++ b/docs/utils/testing.rst @@ -5,6 +5,10 @@ Helpers for Testing (`pyvo.utils.testing`) ****************************************** This package contains a few helpers to make testing pyvo code simpler. +This is *not* intended to be used by user code or other libraries at +this point; the API might change at any time depending on the testing +needs of pyVO itself, and this documentation (mainly) addresses pyVO +developers. The LearnableRequestMocker diff --git a/pyvo/discover/__init__.py b/pyvo/discover/__init__.py index dc6fc609..533735b8 100644 --- a/pyvo/discover/__init__.py +++ b/pyvo/discover/__init__.py @@ -3,4 +3,4 @@ Various functions dealing with global data disovery. """ -from .image import images_globally +from .image import images_globally, ImageDiscoverer diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 6c2be64a..6754c46d 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -13,16 +13,18 @@ import functools from astropy import units as u +from astropy import table from astropy import time from astropy.coordinates import SkyCoord from ..dam import obscore from .. import dal from .. import registry +from ..registry import regtap # imports for type hints -from typing import List, Optional, Set, Tuple +from typing import Callable, List, Optional, Set, Tuple from astropy.units.quantity import Quantity @@ -38,6 +40,7 @@ class Queriable: def __init__(self, res_rec): self.res_rec = res_rec self.ivoid = res_rec.ivoid + self.title = self.res_rec.res_title def __str__(self): return f"<{self.ivoid}>" @@ -115,7 +118,7 @@ def _clean_for(records: List[Queriable], ivoids_to_remove: Set[str]): return [r for r in records if r.ivoid not in ivoids_to_remove] -class _ImageDiscoverer: +class ImageDiscoverer: """A management class for VO global image discovery. This encapsulates all of constraints, service lists, results, and @@ -125,7 +128,7 @@ class _ImageDiscoverer: The normal usage is do call discover_services(), which will locate all VO services that may have relevant data. Alternatively, call set_services(registry_results) with some result of a registry.search() - call. _ImageDiscoverer will then pick capabilities it can use out + call. ImageDiscoverer will then pick capabilities it can use out of the resource records. Records without usable capabilities are silently ignored. @@ -145,7 +148,9 @@ class _ImageDiscoverer: radius = None def __init__(self, - space=None, spectrum=None, time=None, inclusive=False): + space=None, spectrum=None, time=None, + inclusive=False, + watcher=None): if space: self.center = (space[0], space[1]) self.radius = space[2] @@ -158,9 +163,24 @@ def __init__(self, self.inclusive = inclusive self.results: List[obscore.ObsCoreMetadata] = [] - self.log: List[str] = [] + self.watcher = watcher + self.log_messages: List[str] = [] self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] + def _info(self, message: str) -> None: + """sends message to our watcher (if there is any) + """ + if self.watcher is not None: + self.watcher(message) + + def _log(self, message: str) -> None: + """logs message. + + This will also do whatever _info does. + """ + self.log_messages.append(message) + self._info(message) + def _purge_redundant_services(self): """removes services querying data already covered by more capable services from our current services lists. @@ -169,12 +189,38 @@ def ids(recs): return set(r.ivoid for r in recs) self.sia1_recs = _clean_for(self.sia1_recs, - ids(self.sia2_recs)|ids(self.obscore_recs)) + ids(self.sia2_recs) | ids(self.obscore_recs)) self.sia2_recs = _clean_for(self.sia2_recs, ids(self.obscore_recs)) - # TODO: use futher heuristics to further cut down on dupes: - # Use relationships. I think we should tell people to use - # IsServiceFor for (say) SIA2 services built on top of TAP services. + # In addition, now throw out all services that have an + # IsServedBy relationship to another service we will also + # query. That's particularly valuable if there are large + # obscore services covering data from many SIA1 services. + + ids_present = table.Table([ + table.Column(name="id", + data=list(ids(self.sia1_recs) + | ids(self.sia2_recs) + | ids(self.obscore_recs)), + description="ivoids of candiate services", + meta={"ucd": "meta.ref.ivoid"}),]) + services_for = regtap.get_RegTAP_service().run_sync( + """SELECT ivoid, related_id + FROM rr.relationship + JOIN tap_upload.ids AS leftids ON (ivoid=leftids.id) + JOIN tap_upload.ids AS rightids ON (related_id=rightids.id) + WHERE relationship_type='isservedby' + """, uploads={'ids': ids_present}) + + for rec in services_for: + self._log(f"Skipping {rec['ivoid']} because" + f" it is served by {rec['related_id']}") + + collections_to_remove = set(r["ivoid"] for r in services_for) + self.sia1_recs = _clean_for(self.sia1_recs, collections_to_remove) + self.sia2_recs = _clean_for(self.sia2_recs, collections_to_remove) + self.obscore_recs = _clean_for(self.obscore_recs, collections_to_remove) + def discover_services(self): """fills the X_recs attributes with resources declaring coverage @@ -228,6 +274,8 @@ def set_services(self, self.sia1_recs.append(Queriable(rsc)) # else ignore this record + self._purge_redundant_services() + def _query_one_sia1(self, rec: Queriable): """runs our query against a SIA1 capability of rec. @@ -252,12 +300,17 @@ def non_spatial_filter(sia1_rec): return False return True + self._info("Querying SIA1 {}...".format(rec.title)) svc = rec.res_rec.get_service("sia") - self.results.extend( - ImageFound.from_sia1_recs( + found = list(ImageFound.from_sia1_recs( svc.search( pos=self.center, size=self.radius, intersect='overlaps'), non_spatial_filter)) + self._log("SIA1 {} {} records".format( + rec.title, + len(found))) + + self.results.extend(found) def _query_sia1(self): """runs the SIA1 part of our discovery. @@ -266,7 +319,7 @@ def _query_sia1(self): limitations of SIA1. """ if self.center is None: - self.log.append("SIA1 service skipped do to missing space" + self._log("SIA1 service skipped do to missing space" " constraint") return @@ -274,12 +327,13 @@ def _query_sia1(self): try: self._query_one_sia1(rec) except Exception as msg: - self.log.append(f"SIA1 {rec.ivoid} skipped: {msg}") - raise + self._log(f"SIA1 {rec.ivoid} skipped: {msg}") def _query_one_sia2(self, rec: Queriable): """runs our query against a SIA2 capability of rec. """ + self._info("Querying SIA2 {}...".format(rec.title)) + svc = rec.res_rec.get_service("sia2") constraints = {} if self.center is not None: @@ -291,11 +345,9 @@ def _query_one_sia2(self, rec: Queriable): matches = list( ImageFound.from_obscore_recs(svc.search(**constraints))) - if len(matches): - self.log.append(f"SIA2 service {rec}: {len(matches)} recs") - else: - self.log.append(f"SIA2 service {rec}: no matches") - + self._log("SIA2 {}: {} records".format( + rec.title, + len(matches))) self.results.extend(matches) def _query_sia2(self): @@ -305,16 +357,20 @@ def _query_sia2(self): try: self._query_one_sia2(rec) except Exception as msg: - self.log.append(f"SIA2 {rec.ivoid} skipped: {msg}") - raise + self._log(f"SIA2 {rec.ivoid} skipped: {msg}") def _query_one_obscore(self, rec: Queriable, where_clause:str): """runs our query against a Obscore capability of rec. """ + self._info("Querying Obscore {}...".format(rec.title)) svc = rec.res_rec.get_service("tap") recs = svc.query("select * from ivoa.obscore"+where_clause) - self.results.extend( - ImageFound.from_obscore_recs(recs)) + matches = ImageFound.from_obscore_recs(recs) + + self._log("Obscore {}: {} records".format( + rec.title, + len(matches))) + self.results.extend(matches) def _query_obscore(self): """runs the Obscore part of our discovery. @@ -338,7 +394,8 @@ def _query_obscore(self): try: self._query_one_obscore(rec, where_clause) except Exception as msg: - self.log.append(f"Obscore {rec['ivoid']} skipped: {msg}") + self._log("Obscore {} skipped: {}".format( + rec.res_rec['ivoid'], msg)) def query_services(self): """queries the discovered image services according to our @@ -361,7 +418,8 @@ def images_globally( space: Optional[Tuple[float, float, float]]=None, spectrum: Optional[Quantity]=None, time: Optional[float]=None, - inclusive: bool=False + inclusive: bool=False, + watcher: Optional[Callable[[str], None]]=None ) -> Tuple[List[obscore.ObsCoreMetadata], List[str]]: """returns a collection of ObsCoreMetadata-s matching certain constraints and a list of log lines. @@ -383,14 +441,17 @@ def images_globally( Set to True to incluse services that do not declare their STC coverage. By 2023, it's a good idea to do that as many relevant archives do not do that. + watcher : + A callable that will be called with strings perhaps suitable + for displaying to a human. When an image has insufficient metadata to evaluate a constraint, it is excluded; this mimics the behaviour of SQL engines that consider comparisons with NULL-s false. """ - discoverer = _ImageDiscoverer(space, spectrum, time, inclusive) + discoverer = ImageDiscoverer(space, spectrum, time, inclusive, watcher) discoverer.discover_services() discoverer.query_services() # TODO: We should un-dupe by image access URL # TODO: We could compute SODA cutout URLs here in addition. - return discoverer.results, discoverer.log + return discoverer.results, discoverer.log_messages diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS deleted file mode 100644 index 497e723a..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS +++ /dev/null @@ -1,28 +0,0 @@ - - -ROSAT was an orbiting x-ray observatory active in the 1990s. -We provide a table of all photons observed during ROSAT's all-sky -survey (RASS) as well as images of both survey and pointed observations. - -For ROSAT data products, see -http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-survey{'siaarea0': <pgsphere PositionInterval Unknown 133.9490641653 10.95 -134.0509358347 11.05>, '_ra': 134.0, '_dec': 11.0, '_sra': 0.1, -'_sdec': 0.1, 'format0': frozenset({'image/fits', -'application/x-votable+xml;content=datalink', 'image/jpeg'})}Written by DaCHS 2.8.1 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceMetadata for ROSAT pointed observations and the ROSAT All Sky Survey -(RASS) images -Codes used here include: - -=== ============================================================== -im1 photon image in the broad band (0.1-2.4 keV) -im2 photon image in the hard band (0.4-2.4 keV) -im3 photon image in the soft band (0.1-0.4 keV) -ime image of the average photon energy -bk1 background image in the broad band (0.1-2.4 keV) -bk2 background image in the hard band (0.4-2.4 keV) -bk3 background image in the soft band (0.1-0.4 keV) -mex merged map of exposure times for the broad band (0.1-2.4 keV) -=== ==============================================================Access key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageROR sequence numberNumber of follow-up observation (0=first observation, NULL=mispointing)Type of data in the file (associated products available through datalink of by querying through seqno)Publisher dataset identifier (this lets you access datalink services and the like)Link to a datalink document for this dataset, this lets you access associate data)AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAANB2QGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtPhEKTkf/+mw+SqAaWYHPGD4BwBGVzv0pAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltMQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAYbVAYIY18QtAHkAmfLF9ZpfuAAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABJST1NBVCBNZWRpdW0gWC1SYXkAAAABbT4ObdT//buEPiqgGmC2e70+AcARlc79KQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAACmltYWdlL2ZpdHMAAKUnQGCGNfELQB5AJnyxfWaX7gAAADdST1NBVCBQU1BDQyBST1NBVCBTb2Z0IFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAC1JPU0FUIFBTUENDQOeG6tdfMa8AAAACAAAAAgAAAgAAAAIAAAAAAj+JmZmZmZmaP4mZmZmZmZoAAAAESUNSU0T6AABUQU4AAAACQHAIRD1GsmxAcAhEPUaybAAAAAJAYIYAAAAAAEAmgAAAAAAAAAAABL+JmZmZmZmaAAAAAAAAAAAAAAAAAAAAAD+JmZmZmZmaAAAAEFJPU0FUIFNvZnQgWC1SYXkAAAABbT41TOHhNKWsPkqgGlmBzxg+KqAaYLZ7vQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTMAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltZS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAUTpQGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtf/gAAAAAAAB/+AAAAAAAAH/4AAAAAAAAAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltZQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3o=
Datalink service for ROSAT images. This gives access to images in the -various bands, background maps, and other ancillary data. - -For more detailed information on the various data products, please -refer to http://www.xray.mpe.mpg.de/rosat/archive/docs/rdf.ps.gz
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-KwbduA7iAm3yI+JS.meta deleted file mode 100644 index d376d94d6cf92849b54c922d55dcee7e5451cb8f..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1758 zcmZ`)QE%f!5H2)rLsPCT1q6bVqDoZlU1P@yE!Uz5l_VU!JCdjghlGU8+TO%_b!^wW zZktM#xEDmFePj6v{1@K&LwuV!Nl!ZRklmS`nVp?)zVUClzy4ib82@h7t}JjtM9OV9 z@~C?Lk6iI7@o2)8+)C(0O1a<$7fI@hG@)8sC!C&!oQ9kUc1at|73xp5_gdX5xomS0 zB~;0R8wCM%1&c!X6xsAA)Y@r^WOC7&{ca%eIzJZdHpC&Iii+0f*S#0Dz! zO{d+hS=BF%@)wo5Wf|q2?&;6XTG_C6PFua^S+`m5)!HwcXD?1V-5spo)+)+>*Iyd< zl%Mwtd%9s(Q=nfW0~Acj)gQHRG7+A{qnB;dG7gZyrS(OeZj)?dQW4vPF$D9;$9c7pG-9K9^4$sL{=XdC@u3)Y_P#GgED5u<-iW=ov}o0Ik?@ zgkBse`9Py$Oq^c9L~b=`pP-K>UY&_qMp86HNCkHZ+WQYQSKqB19UiDV@Eu#Ld}I@D z&n#MU%?G|&k`yzEQI2-Op!&h(-0hGeWsa#8$QmCL;mK;o!pq8WWk;< z$j|3WPKC`vu!sb>EePTkdm``?`L?XiMK{c0jQLrvvajrqxu$=&` zpjUIc?7zc&l0mHBBmG -Definition and support code for the ObsCore data model and table.{'pos0': <pgsphere Circle Unknown 134. 11. 0.1>, 'BAND0': -2.0664033072200047e-09}Written by DaCHS 2.8.1 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. -The calib_level flag takes the following values: - -=== =========================================================== - 0 Raw Instrumental data requiring instrument-specific tools - 1 Instrumental data processable with standard tools - 2 Calibrated, science-ready data without instrument signature - 3 Enhanced data products (e.g., mosaics) -=== ===========================================================High level scientific classification of the data product, taken from an enumerationAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lamdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.AAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6AAAAPlJPU0FUIFBTUENDIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9iazEuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAADLAAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAVgAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTEuZml0cy5negAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAANAAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+SqAaWYHPGH/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQyBST1NBVCBNZWRpdW0gWC1SYXkgMTk5MC0xMC0xOSAwODowNzo1MS41MDAwMTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAAAAAAHpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABgAAAAAAAAAAEBghjXxC0AeQCZ8sX1ml+5AGZmZmZmZmgAAAH5Qb2x5Z29uIElDUlMgMTM1LjQwNDkzMTgyNTkgOC4wNDY4MDY3ODQ4IDEzNS40NzY5MjI2MzE5IDE0LjQxNzQ0MTgzODggMTI4Ljg5ODUwNTQ1MjIgMTQuNDE3NDQ3NzcxNSAxMjguOTcwNDg2OTI5MiA4LjA0NjgxMDA0NzNARoAAAAAAAEDnhurXXzGvQOeG6tdfMa9/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENDAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0BGgAAAAAAAAAAAAAAAAIdodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWUAAAAFaW1hZ2UAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAADwAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazEuZml0cy5negAAAD5ST1NBVCBQU1BDQiBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkzLTA0LTI1IDE3OjI3OjQzLjEyOTk5NgAAAFtpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6AAAAAAAAAHJodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAbAAAAAAAAAABAYJtFRGOCNEAnp9uUMZwPQAERERoDt0UAAAB+UG9seWdvbiBJQ1JTIDEzMy45MzM0MTYyMTA0IDEwLjc2MzU5MDAwMTEgMTMzLjk0MTg3OTk4OTIgMTIuODkyMTI4MzMxOSAxMzEuNzU4Mjc0Mzg1IDEyLjg5MjEyODkyMiAxMzEuNzY2NzM3MDYwNyAxMC43NjM1OTA0OTEyQC4AACGN70FA5/nXSFskwkDn+ddIWyTCf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQgAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ALgAAIY3vQQAAAAAAAAB/aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABHcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAA5Uk9TQVQgUFNQQ0IgUk9TQVQgTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABUAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQiBST1NBVCBNZWRpdW0gWC1SYXkgMTk5My0wNC0yNSAxNzoyNzo0My4xMjk5OTYAAABbaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAAAAAAAByaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAIAAAAAAAAAAAQGCbRURjgjRAJ6fblDGcD0ABEREaA7dFAAAAflBvbHlnb24gSUNSUyAxMzMuOTMzNDE2MjEwNCAxMC43NjM1OTAwMDExIDEzMy45NDE4Nzk5ODkyIDEyLjg5MjEyODMzMTkgMTMxLjc1ODI3NDM4NSAxMi44OTIxMjg5MjIgMTMxLjc2NjczNzA2MDcgMTAuNzYzNTkwNDkxMkAuAAAhje9BQOf510hbJMJA5/nXSFskwn/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0IAAAAAAAACAAAAAAAAAAIA////////////////////////////////QC4AACGN70EAAAAAAAAAf2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWU=
A datalink service accompanying obscore. This will forward to data -collection-specific datalink services if they exist or return -extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml_band=['2.0664033-aq1D4amuVbxvuUzJ.meta deleted file mode 100644 index 197c6d2c1238520fc4d95035110c4180108bee82..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1853 zcmb7FT~Fgi6h$QvMCbxVTeWIevQSmQLLA58W1&J7P3U$%8X}&m>O5R#a;95YN4H@15~I=Uo3>`ok?x4SqLzO;v=XG8e>8 z0;XU5rOF|r0n3C|D;ay8Ga-d7WS09f&zSKxsbJ4y!D7KBzho`$OZ~fEf2(h_nk7Oe z8PlrbCsD+F$&(m4mE#O0Sulz{!MV#aqp|3+tjc1X&Es>emd{4Mqp`2-hk1O#0{sih z3zl8742#oZ@u)?c-<;N5`-xq*(`Gw}<45=$1#s_du8TWA*M*}(jmrfI}|YF?~%UA;^s^&+-$ z-HS}_$|yJBB27$xlGt>tDABs>U8Pb|KkVVCFRU()SWJ8DU==;iBWc^Hyo!>!@Km|L zL92%&L`X03FYK{@g`5nbI`&?n>76XO?vF58Q*&e-xHu|c_W*YUXcjveODV7^DooO5 zdrXE&pw;x#qci;HS)|o(p_J)MngzHlzAtQ%&{=b%ZIo};r`&3|W%!=dpc?SFq1BPlv2ot@ zws*QauniaL4v5j|~4K9sg9J`ha z{6upQ^qgiBB+DdCK-#`m4-9r>I}mQHG?@ZlftLa!LMLp*LU}J zw)HIr1D17Xk5ECz5pA^)0_Nh9F2df&*uZcgLDHi -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-6KacUiZqroafSOt%.meta deleted file mode 100644 index 00a8d1bcb7c6391c906d73975e36f8fb01a20e10..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3019 zcmdT`-EI>{6pl(lQbGwSYNe_mxfel!#cS`H{1}M~j#h_^+Kh`hy2aVskO?VtA$e%YkTZp?Qo#;A!93weXUq;9OUA#&_uj|v z;^-<7(&sFW)-B(4nI#?H1J8PkLnO0jv~B3!l$?5^&v>4B(Cv7GINI#aaJ4yZ)f$H0 zDYN5WAYL#&W*nPNwz+datIs+GQ{UH(oSZm9GW!+l70jYu(u;~`*`^W(EgvMyojP|O z?YthGzeVBqUvIWv;5eX zwC6JIY~+GB6uoFQb6OmIHFF;s`PQjE$KN9D)UU1H8+hoL`)AXc1Gl3!GAG=a3D8G~ zjSD|+9CH>>I5Ly4V7oeEa_HN*=W(mkjiW0ecjM^xP|Dy@p}^TdAHZ1M=YxWzK|xGC zD;|C}TuH(d zit}p9iA~CYi`_5WS0~pHCNE7e00`0oIAtuzQy00Z2ye{d=`wF1hd|6C+Q<;g#>1UG zMS6MYzxy!slgT9C_xUIfPbV3iq^L@PHPn)S>ZoG5IS=6+wVB0ER1>1-lrN&VN&+9* zHHDEXa(c@21|-p~1JY?c{mg6s>_H>#M}{)jpr5Z`8qOcDt_RGrgzRIWqA*V(ZrK0G;(ZZ1wTVc#!B zw--pkByl|S4eCOh>*8kT(U%{d2NY3KqL_t_LjvwgAKe7rTv1NJdSxPniq}ojb5UB% z&MX)4J>aP8`jZQ|X0%K^e-c0c-F)5n#A7md5Xw_iW*)Ec#FcdJ-&#=c{3nN{i!+K=N(6hGfN2+6sPjV(VwHeYDgu!r z#?%cn3kDEP{66~0fbzuN2_3T@^^!gAp=r1Y8a7AoC3G;@GWV;kN~6}P*05ETClKJ& zoGo)N`N~R{+LbEl7fiL6Elsdsj!EgXN=I9W5DDAAsl+7mY}iUt_kNPj3o<@VspHB1 z+^wIaaxURNDCB;c8=tOFNf3x)z1=#(!Z{{PngoEFmF`Kq($E^UdRJ?mbZc$xdF!yL zfeKxM_8ixd)63~_E5`fOVwaPtOt+b&j(a(skQNarZB+ip5Tdj5g!0w1TDt}gWMry_ zoT&z(ZIup^JT&VUE@aj*?CFu3mRn|h>tPWIo>$4Vr&XEO@Jz?RMvt{li;X_T7VWF1jfVfmmwbkra4x1eyj#^dx z@2VQ89=59uRbEEvp@I!V{TFpCi5LKuk7kP*oMA2qF6+BSskl?#FP6&cx6ks%p7x~H zeO0S9H4&svLq$_A6JzEmrixw}`Lx|SIo6)M#unH5f44C;5HLf9dU&oO4+Fe4S^Q%x zq8miDbqrJWMD@M68LFwAgd4BNX0)!_8o^6S3WBi@z;${$VDLxl$7*defoY4;yd5p8 zu>-P;uc$cseDRQqmf~SJ3}yTtvx&S-4IuvHIc kbcF2+u^3k@YijPDsW(LOG>bNfN?1&T?A0BghrLk$2QphCzW@LL diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY deleted file mode 100644 index e7a20f7a..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY +++ /dev/null @@ -1,25 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAB2NhdGFsb2cAAAAHYmliY29kZQAAABMAMgAwADAAMABJAEEAVQBDAC4ANwA0ADMAMgBSAC4ALgAuADEAVn/AAAAAAAAFeC1yYXkAAAA0aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL3NpYXAueG1sPwAAABZpdm86Ly9pdm9hLm5ldC9zdGQvc2lhAAAADHZzOnBhcmFtaHR0cAAAAANzdGQ=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-D3rLu5ZOjOY497iY.meta deleted file mode 100644 index a8da7d053d0f0513e019870def4d2690285e1b2a..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2885 zcmdT`-*3}a6s|@~JIW{>+N5b9We-IyCQh8JrK!Y2NKz<-BqS+}hw19ZzKKm8+uVDd zG?S3V%d|>CpbgDeEM<_7dJa^oV7 zTOG~f9K7zBl&qoDGgMyfOW^8|D zuO(@-H|)(lm6K~B0-UEK96ye(ohqW55{JR;WxHVL`?|#@#)Gmp8V>dkh6kWk6pbQ6 z+L^%xuTa(vLoelan~oQr@2QY(QPX6Byp-szYRXxrd3*Gm6Wq^PZ0I6U_j3cTG_R(b zSfmO#*uBC%_2nAUY_H4;Ej1cUFMCX4aPj9&5W^XluKnL`tj8N z^kM3!(`kO_^Kl-LPAWJlQB?vP=q3NmQO$C5k-`OQJIkG@B|=XrUuJQg1U{;31}9bK z^i=5$M50@DHl(2|Q>{)ambD$K#$!^L6b1VyDsX6)DhK=V1v(f@qgWwSkcC7mx^6ob z%bYAh>>Knqx|mr0m^vO9KW2=~5(zzYoilV)tz(Dpv(KLR@XJMXbNMAR_G~4(y<`d| ziQ@q`sEgfP7bm-jzWwlfK#?V7ikUzh5^!JoKodlBO$7z-D^np!oAi98Fwk~F+uwC5!opSG#v$>AcbU$o`I z!e?yA{j@f|d_!eHAdAP{_H(>A$An3X0932mKkZhVTC;K7*V?E3Mpt{c6Ptm6!ox`hYo1zl?Lqa78~b%EkT4VX<6MzeAQc9%zpm{a1}fOA|qQEc6oP zGI3_XVyfMglaIUY(~kD&HJ1N-08vnk=_S;aZv$l);FibYUtc3v~h21MVksx2<|Xa5DZ)pt~1aymgWcvzZ!|3jG)zW4T65#+Ay3nmFfb XdMB5nXp5M*@B)Xk`)+&@4nqB3NbUBW diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW deleted file mode 100644 index afc3d06d..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW +++ /dev/null @@ -1,25 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAAAAAAAAAAAAAAH/AAAAAAAAAAAAARGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9zaWFwMi54bWw/AAAAIGl2bzovL2l2b2EubmV0L3N0ZC9zaWEjcXVlcnktMi4wAAAADHZzOnBhcmFtaHR0cAAAAANzdGQ=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-hnTgQr6M2jpFuoIW.meta deleted file mode 100644 index 3a7bd052a9a85b0742dba34b3585c39f1522a591..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2895 zcmdT`QIFF`5I&VV?#fY)D{7^xAf*q74osZb=^Ym&9zv3XgOD6a4$4Ed+Sr@eoMW5a zb#keMR9>o{hkQ%EW! zL9D=L$+N%Xb%#-#agoF~IC~p0A%!j^k1QE+rnq$~*pV-oFI?$PSi`ks@<(##eey1e zFB2gH&XRc33OtWl(hYp*Y<4(IGJ7uD#lG8;Q(p`jFESr{yZ$JNxBGKmbHQ7;oX9_A zcJdp{3&tmmW6{eOw;Htmq*pTa1KlXdsVgM2U$H^SEbA4$taMgwD&f#-BYoXEVrz9@c4OO$zQbsUou}7r`LxZ;);l*UsP#B6Q4yv)Md=yYU8D2yV>{=wsx@ zLman`ISVNQnOj(@T^=*(1UAlj-0Ag`_)^5ZB);iL89peLI2-9BII9PIRFX6-iJ5OD z&KJ&Fnl@*{*}S82awS55i*$tJC-IdNMbt9lAe_DIlni}Ox7ozFU(rUx!QTFGAGC_1 zQAS9QXK=wURdmD9&BAWW^`o;pDx_P~vREiDBzmisah7S`9{u8m_X;)}dPvm0!hkEy z%b6w?nF0=Ww{%y1xq>wL8NfgwNlW6Cv9L%zU{eWRo9EMG{zy7t%rn}`8LLL6QcIQd;yMWfplb#v zRp#_e=?z5U8x1z3ktZ{)<4i0sJD|pAQdks#{T&D#T4r^BFF8jAV`-GDgbK2dXvbF_ z*JinsCd9r%eWQwr9gL~#gYkXN$Ssk`N7cDQS79AHe4Bsv#fM+cWxv^&}@y#Vu zFiBh=eS><~>@w^Z4rzzlRiAQl^-NjzdBo$N=30(OgqO!TZuw2$iqvWZ~^cxe*Cc3c+t8Ie)sjmUbEG#_jk%QcM`bvj#<~x4~gm$YAu|AOXAaUN~K?1>7_&t zK;p3p^X7Us6Bc(v)kiWGIw4@h2;ig`7H1T#lnC}VC9^KH+%AYXgcSg(R01MnOsE&- z9*kg`1Vi+b5#_1BQ#xS->Zfa*L(^~)G;EIEOXz5{V;}Z083r;4d)q2{}ghVKNYaYS;QF-C9d)H4pn*=cM24YEL^yZ4FZB z5_I5tuAF^b4yR&#NGQ;{|x92)6<>Jj}tIbHQ*`-#04dz3M@^QdPeLRy6Kw zkDC2g&1PE@VRk@N73DH@X2D{r@RXB}yPcC`?a^y2|M#s#HD$~(p)P+L0APsw9!q{s zM0|~?){23qu8D!4v?Dbc(XA{8H@J4ZsagxcZAJ=$(F?+J2Rdlz$D7CM-DLt3594t+ zURA9hVi#{RN&MyVG83;PPUJ)~d5`%(-ewLF>5f?dW_vyt&<$;uBS`|hb&`&?nHrj^ n4>CH&a*bGwE0qm3d(PAxPp?Pu7O`;kMMutWzR7tsi1dE|v(fsg diff --git a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk b/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk deleted file mode 100644 index f5900c6f..00000000 --- a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk +++ /dev/null @@ -1,17 +0,0 @@ - - The Bochum Galactic Disk Survey is an ongoing project to monitor the -stellar content of the Galactic disk in a 6 degree wide stripe -centered on the Galactic plane. The data has been recorded since -mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at -the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean -Atacama desert. It contains measurements of about 2x10^7 stars over -more than seven years. Additionally, intermittent measurements in -Johnson UVB and Sloan z have been recorded as well.{'siaarea0': <pgsphere PositionInterval Unknown 115.9428322966 -29.05 -116.0571677034 -28.95>, '_ra': 116.0, '_dec': -29.0, '_sra': 0.1, -'_sdec': 0.1, 'format0': frozenset({'image/fits', -'application/x-votable+xml;content=datalink', 'image/jpeg'})}Written by DaCHS 2.8.1 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataLegal conditions applicable to (parts of) the data containedContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceAccess key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageSurvey field observed.Effective exposure time (sum of exposure times of all images contributing here).Dataset identifier assigned by the publisherAAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBiJAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA2jAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCzWgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfrgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBe+gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEOgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCBFAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDElAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHvgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB3PAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHaAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+FwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD+DwEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgCAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjI3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJyiUsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjIyOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5ICp6IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA9ZwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBT5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEWfgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDInwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAAaAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/5BgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/98gEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2CQEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDxOgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDzKQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/k/AEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDPegEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIxVDA0OjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXMCp8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDTKwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjEzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaPXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC95gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjI0OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI3wEkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjuQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBm4wEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIxVDA0OjA1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXKJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjMxOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLC8HMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwBwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCrngEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWhgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFeQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCRxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCOnQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCenAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1dgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1egEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2vQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUkwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqNgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCN6QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6DAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCiTQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAsAAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjEzOjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaN18wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjBQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjI0OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI2O+wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKDwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjU4OjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUwi5EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkEwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjMzOjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL9uXUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjMyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLmlvIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjM3OjE0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSrAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBd7AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRRAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB2tQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/BIAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB7+wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBGBAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSfwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBxQgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkbQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBlqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6OQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHkQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjU4OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUyD+4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAH9wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBBGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhcAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCt5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjM0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJMJe0IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCoGgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjMzOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL/PdIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCREwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjMyOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCebwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjM3OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNQBhEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCI/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCpQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjU2OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZUE7i0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDK6AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjUzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRTIP7cAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgNQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjMwOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHo1niawAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBHxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjMxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLDsqIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOmQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDeawEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA4VDA0OjA1OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBXRWeIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfVAEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBTMwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCLGQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDWKAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDsqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZUgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBLSgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUbgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBR+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUyAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBsKQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjMgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9WEwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUwAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDIGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+cQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAKxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1HAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5IDCLkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKNAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjI3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJy6mIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBecwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBc3gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBdvwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+d+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB/UgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZAAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjI1OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI5pbwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjE1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FaQ4IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEZwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIxVDAzOjU3OjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUi5FAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRDwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjA2OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCsrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjE3OjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjUwOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRSBU9EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCkPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjI2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJJXOskAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaZAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjI2OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJQZykAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHlQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCQuQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC+bQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCKCwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3OAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5hQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo0gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4qAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5WAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAU+QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE2VDA2OjU1OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCS1QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0EgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqYwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBA6wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDC0gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/n+QEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAyOjQ2OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7UAYQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgYgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZLQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB11AEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDMfQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI0VDAxOjMxOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4goM5QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaCgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDN5QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBORwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBNDAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRngEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSJQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBMKwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBL0QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9IAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZ4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjI0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQl7QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBifgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcKgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfgQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjIzOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHoy/hqMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBJiAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDA4wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC66QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDLAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjI0OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQNp0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCXlAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCSwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCx8gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDjKgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDnjwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjM0OjE4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP23LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBABdgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/7fAEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/6QQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBACKgEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/9mAEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDS0QEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEJTwEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD49gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwuwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI0VDAxOjMxOjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4golKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo/wEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBunwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1pwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfJwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBf2wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCCTwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBpWQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBtvgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCEawEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBg6QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmtgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBIpwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE2VDA2OjU1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTlEpUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBx9gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBByIwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhQwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgvAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE1LTAzLTIwVDAyOjQ2OjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7ToG0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+VLgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBvrQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBPVQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB8ggEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmXAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjM0OjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP22zY8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKwwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjI5OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKdZIEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBXmAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjI1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjUwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRR/z3QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBaOwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjE3OjI2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGMtIcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjA2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXlc60AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmLwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIxVDAzOjU3OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUgncYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBYeQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjE1OjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FZgVQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBOzgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGVgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCh8wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGgwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjQ2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRQc0t4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3CwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjQ4OjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZRU9D4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCG4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCbnwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjI5OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKeJq8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdNAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjI1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI6Z+sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6
This service lets you access cutouts from BGDS images and retrieve -scaled versions.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk.meta b/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml_intersect=['over-VQN20JIanSxbrIwk.meta deleted file mode 100644 index c204a5a364039232899b642d99ea70ffbfb20ba0..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1761 zcmZ`)ZBHXN5T+%Nl+Xi8TeWIWija!nj(C#=j+ZK`XcAqyyCxAyuhK~;*Xwn%J~q3{ z+6x2;seGx5@*N85M1(0*5Fj?zx4KNap^^9LuhtT~skXIhRPdP_B^sw`RC0Z{7+(EE6^Gz2ZS~y=_QaA(XO6J}ASLlQA+Y!nMH-k9JBf>-$hfJ0&MJo{M8on2a4D zNl&aNW@iZsAsClGEP(&n;+(OlOngvIMsES67oKyYt<@<#Q)n&YMbuNH7bKoBl*dsB z#W>RHk)Z{Ro!)_oT5qsEfkGO4b;f3yN}(bGCIux>-+w}N^{IXIY+v7l;9**=9AP5x z)S{)9Js>!{qzz`DLOTG_V>cWU9sux724saTru|mpfc%C;QV-fzOBFGw2!r0Fz|dP@;d2MU8vIqUW5%pjI%2j}e}Ji}ZcsB -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL2JnZHMvcS9zaWEAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAIYmdkcyBzaWEAAAApAEIAbwBjAGgAdQBtACAARwBhAGwAYQBjAHQAaQBjACAARABpAHMAawAgAFMAdQByAHYAZQB5ACAAKABCAEcARABTACkAIABpAG0AYQBnAGUAcwAAAAhyZXNlYXJjaAAAAgsAVABoAGUAIABCAG8AYwBoAHUAbQAgAEcAYQBsAGEAYwB0AGkAYwAgAEQAaQBzAGsAIABTAHUAcgB2AGUAeQAgAGkAcwAgAGEAbgAgAG8AbgBnAG8AaQBuAGcAIABwAHIAbwBqAGUAYwB0ACAAdABvACAAbQBvAG4AaQB0AG8AcgAgAHQAaABlAAoAcwB0AGUAbABsAGEAcgAgAGMAbwBuAHQAZQBuAHQAIABvAGYAIAB0AGgAZQAgAEcAYQBsAGEAYwB0AGkAYwAgAGQAaQBzAGsAIABpAG4AIABhACAANgAgAGQAZQBnAHIAZQBlACAAdwBpAGQAZQAgAHMAdAByAGkAcABlAAoAYwBlAG4AdABlAHIAZQBkACAAbwBuACAAdABoAGUAIABHAGEAbABhAGMAdABpAGMAIABwAGwAYQBuAGUALgAgAFQAaABlACAAZABhAHQAYQAgAGgAYQBzACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAHMAaQBuAGMAZQAKAG0AaQBkAC0AMgAwADEAMAAgAGkAbgAgAFMAbABvAGEAbgAgAHIAIABhAG4AZAAgAGkAIABzAGkAbQB1AGwAdABhAG4AZQBvAHUAcwBsAHkAIAB3AGkAdABoACAAdABoAGUAIABSAG8AQgBvAFQAVAAgAFQAZQBsAGUAYwBzAG8AcABlACAAYQB0AAoAdABoAGUAIABVAG4AaQB2AGUAcgBzAGkAdABhAGUAdABzAHMAdABlAHIAbgB3AGEAcgB0AGUAIABCAG8AYwBoAHUAbQAgAG4AZQBhAHIAIABDAGUAcgByAG8AIABBAHIAbQBhAHoAbwBuAGUAcwAgAGkAbgAgAHQAaABlACAAQwBoAGkAbABlAGEAbgAKAEEAdABhAGMAYQBtAGEAIABkAGUAcwBlAHIAdAAuACAASQB0ACAAYwBvAG4AdABhAGkAbgBzACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABvAGYAIABhAGIAbwB1AHQAIAAyAHgAMQAwAF4ANwAgAHMAdABhAHIAcwAgAG8AdgBlAHIACgBtAG8AcgBlACAAdABoAGEAbgAgAHMAZQB2AGUAbgAgAHkAZQBhAHIAcwAuACAAQQBkAGQAaQB0AGkAbwBuAGEAbABsAHkALAAgAGkAbgB0AGUAcgBtAGkAdAB0AGUAbgB0ACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABpAG4ACgBKAG8AaABuAHMAbwBuACAAVQBWAEIAIABhAG4AZAAgAFMAbABvAGEAbgAgAHoAIABoAGEAdgBlACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAGEAcwAgAHcAZQBsAGwALgAAAC9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvaW5mbwAAACwASABhAGMAawBzAHQAZQBpAG4ALAAgAE0ALgA7ACAASABhAGEAcwAsACAATQAuADsAIABGAGUAaQBuACwAIABDAC4AOwAgAEMAaABpAG4AaQAsACAAUgAuAAAABnN1cnZleQAAAAdiaWJjb2RlAAAAEwAyADAAMQA1AEEATgAuAC4ALgAuADMAMwA2AC4ALgA1ADkAMABIf8AAAAAAAAdvcHRpY2FsAAAB6Wh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsbWV0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsZ2V0Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL3NpYS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9CR0RTOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9iZ2RzL3Evc2lhL3NpYXAueG1sPwAAAURpdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NvZGEjc3luYy0xLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eDo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAADKdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnI6d2ViYnJvd3Nlcjo6OnB5IFZPIHNlcDo6OnZzOnBhcmFtaHR0cAAAAH5zdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjpzdGQ=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync_LANG=ADQL&QUERY=-FLW0oQODrCtVUdcJ.meta deleted file mode 100644 index fb7279b481268306c214a413820dd37e7034570b..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2634 zcmdT`TW=Fb6po4^X+jApYNe_mxeq}Ji`VuVNP>ha*KxQR+t?12hiWw59q%q#?=Ca5 zc3cSwUaCggw{HJa|3&{wzu8^e;RRaWYFXMjXU=8jT)s2!3V;5%zLNglCOh$lkW@y3 zn1RKTr+>w(4x<+1B8jhY_9kLN3SCGZnKI%`aT`>y$G%{`aHTt8hps7;Ka$<|$=f8p zM1%}DOX3YP@H}QpH}Ije(cv)3thsCtezzp2z8EoHVm^GkzMaHdgE_Cc;H{cYd;;}gcQ=;w{ltU6<}LeIH@sc6*vLboZWo7K zXT)MH_H-q_ zzGMm}iR%M5s0VMJhnt09_I`vkw-)Lf~I!_?M*>Sdw zz4U*ee5qBfp8dm__M)Q+7A`oMoL28^OA{hh`;<#eBHzMUNfzGE@_Ek2zjNyPaOt)M5KrPSmvcN` zNu0=uWbz)+NZw=zBGMhR0L=Cr5&;C3%P}$qc&j8u^qHC$3IZ4%V|kI7j4PEj1-qwe XgrzToc$1iT^#P3XM_+Ol4I}*@y?e2e diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 3ec50f16..6e667ec6 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -29,13 +29,13 @@ def _sia1_responses(requests_mock): def test_no_services_selected(): with pytest.raises(dal.DALQueryError) as excinfo: - image._ImageDiscoverer().query_services() + image.ImageDiscoverer().query_services() assert "No services to query." in str(excinfo.value) def test_single_sia1(_sia1_responses): sia_svc = registry.search(registry.Ivoid("ivo://org.gavo.dc/bgds/q/sia")) - discoverer = image._ImageDiscoverer( + discoverer = image.ImageDiscoverer( space=(116, -29, 0.1), time=time.Time(56383.105520834, format="mjd")) discoverer.set_services(sia_svc) @@ -63,3 +63,23 @@ def test_cone_and_spectral_point(_all_constraint_responses): # expected failure: the rosat SIA1 record should be filtered out # by its relationship to the sitewide SIA2 assert len(logs) == 1 + + +@pytest.fixture +def _servedby_elision_responses(requests_mock): + matcher = LearnableRequestMocker("servedby-elision-responses") + requests_mock.add_matcher(matcher) + + +def test_servedby_elision(_servedby_elision_responses): + d = discover.ImageDiscoverer(space=(3, 1, 0.2)) + # siap2/sitewide has isservedby to tap + d.set_services(registry.search(registry.Ivoid( + "ivo://org.gavo.dc/tap", + "ivo://org.gavo.dc/__system__/siap2/sitewide"))) + + assert d.sia2_recs == [] + assert len(d.obscore_recs) == 1 + assert d.obscore_recs[0].ivoid == "ivo://org.gavo.dc/tap" + assert ('Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because it is served by ivo://org.gavo.dc/tap' + in d.log_messages) diff --git a/pyvo/registry/rtcons.py b/pyvo/registry/rtcons.py index 08d3d6cf..1ea1f5bf 100644 --- a/pyvo/registry/rtcons.py +++ b/pyvo/registry/rtcons.py @@ -779,10 +779,7 @@ def get_search_condition(self, service): raise RegTAPFeatureMissing( "stc_spatial missing on current RegTAP service") - self._fillers = { - "geom": geom,} - - cond = super().get_search_condition() + cond = super().get_search_condition(service) if self.inclusive: return cond+" OR coverage IS NULL" else: @@ -885,11 +882,11 @@ def _to_joule(self, quant): raise ValueError(f"Cannot make a spectral quantity out of {quant}") - def get_search_condition(self): + def get_search_condition(self, service): if "rr.stc_spectral" not in service.tables: raise RegTAPFeatureMissing( "stc_spectral missing on current RegTAP service") - cond = super().get_search_condition() + cond = super().get_search_condition(service) if self.inclusive: return (f"({cond}) OR NOT EXISTS(" "SELECT 1 FROM rr.stc_spectral AS inner_s WHERE" @@ -976,12 +973,12 @@ def _to_mjd(self, quant): " single time instants.") return val - def get_search_condition(self): + def get_search_condition(self, service): if "rr.stc_temporal" not in service.tables: raise RegTAPFeatureMissing( "stc_temporal missing on current RegTAP service") - cond = super().get_search_condition() + cond = super().get_search_condition(service) if self.inclusive: return (f"({cond}) OR NOT EXISTS(" "SELECT 1 FROM rr.stc_temporal AS inner_t WHERE" From 826f0513e3dee9b500563b8ae9640a23d35b178d Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 5 Feb 2024 11:58:58 +0100 Subject: [PATCH 09/38] Updating global discovery test data Also, some changes to make registry requests more predictable (i.e., sorting the extra tables to have a deterministic order). --- docs/utils/testing.rst | 7 +- pyvo/discover/image.py | 7 +- ...ni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS | 28 + ...idelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta | Bin 0 -> 1756 bytes ...i-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ | 18 + ...delberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta | Bin 0 -> 1851 bytes .../GET-reg.g-vo.org-capabilities-VYcr5usI | 162 ++ ...ET-reg.g-vo.org-capabilities-VYcr5usI.meta | Bin 0 -> 1504 bytes .../GET-reg.g-vo.org-tables-Mffx+yRe | 1809 +++++++++++++++++ .../GET-reg.g-vo.org-tables-Mffx+yRe.meta | Bin 0 -> 1431 bytes .../POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD | 27 + ...ST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta | Bin 0 -> 3153 bytes .../POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y | 7 + ...ST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta | Bin 0 -> 3168 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ | 27 + ...ST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta | Bin 0 -> 3163 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr | 28 + ...ST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta | Bin 0 -> 3287 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill | 7 + ...ST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta | Bin 0 -> 3161 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg | 23 + ...ST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta | Bin 0 -> 2962 bytes ...ni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk | 17 + ...idelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta | Bin 0 -> 1759 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi | 23 + ...ST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta | Bin 0 -> 2900 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl | 7 + ...ST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta | Bin 0 -> 3088 bytes pyvo/registry/rtcons.py | 2 +- pyvo/utils/testing.py | 1 + 30 files changed, 2193 insertions(+), 7 deletions(-) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta create mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill create mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta create mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg create mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta create mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk create mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta diff --git a/docs/utils/testing.rst b/docs/utils/testing.rst index 0f3e83cb..54617d7b 100644 --- a/docs/utils/testing.rst +++ b/docs/utils/testing.rst @@ -46,9 +46,10 @@ out which response belongs to which request; it consists of the method, the host, the start of the payload (if any), and hashes of the full URL and a payload. -When the upstream response changes, all you have to do is remove the +When the upstream response (or whatever request pyvo produces) changes, +remove the cached files and re-run test with ``--remote-data=any``. We do not yet have a good plan for how to preserve edits made to the -test files. Let us see how far we get without opening that can of -worms. +test files. For now, commit the original responses, do any changes, and +do a commit encompassing only these changes. diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 6754c46d..8b5aafdb 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -199,9 +199,10 @@ def ids(recs): ids_present = table.Table([ table.Column(name="id", - data=list(ids(self.sia1_recs) - | ids(self.sia2_recs) - | ids(self.obscore_recs)), + data=list( + sorted(ids(self.sia1_recs) + | ids(self.sia2_recs) + | ids(self.obscore_recs))), description="ivoids of candiate services", meta={"ucd": "meta.ref.ivoid"}),]) services_for = regtap.get_RegTAP_service().run_sync( diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS new file mode 100644 index 00000000..f48359c7 --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS @@ -0,0 +1,28 @@ + + +ROSAT was an orbiting x-ray observatory active in the 1990s. +We provide a table of all photons observed during ROSAT's all-sky +survey (RASS) as well as images of both survey and pointed observations. + +For ROSAT data products, see +http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-survey{'siaarea0': <pgsphere PositionInterval Unknown 133.9490641653 10.95 +134.0509358347 11.05>, '_ra': 134.0, '_dec': 11.0, '_sra': 0.1, +'_sdec': 0.1, 'format0': frozenset({'image/fits', 'image/jpeg', +'application/x-votable+xml;content=datalink'})}Written by DaCHS 2.9.2 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceMetadata for ROSAT pointed observations and the ROSAT All Sky Survey +(RASS) images +Codes used here include: + +=== ============================================================== +im1 photon image in the broad band (0.1-2.4 keV) +im2 photon image in the hard band (0.4-2.4 keV) +im3 photon image in the soft band (0.1-0.4 keV) +ime image of the average photon energy +bk1 background image in the broad band (0.1-2.4 keV) +bk2 background image in the hard band (0.4-2.4 keV) +bk3 background image in the soft band (0.1-0.4 keV) +mex merged map of exposure times for the broad band (0.1-2.4 keV) +=== ==============================================================Access key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageROR sequence numberNumber of follow-up observation (0=first observation, NULL=mispointing)Type of data in the file (associated products available through datalink of by querying through seqno)Publisher dataset identifier (this lets you access datalink services and the like)Link to a datalink document for this dataset, this lets you access associate data)AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAANB2QGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtPhEKTkf/+mw+SqAaWYHPGD4BwBGVzv0pAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltMQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAYbVAYIY18QtAHkAmfLF9ZpfuAAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABJST1NBVCBNZWRpdW0gWC1SYXkAAAABbT4ObdT//buEPiqgGmC2e70+AcARlc79KQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAACmltYWdlL2ZpdHMAAKUnQGCGNfELQB5AJnyxfWaX7gAAADdST1NBVCBQU1BDQyBST1NBVCBTb2Z0IFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAC1JPU0FUIFBTUENDQOeG6tdfMa8AAAACAAAAAgAAAgAAAAIAAAAAAj+JmZmZmZmaP4mZmZmZmZoAAAAESUNSU0T6AABUQU4AAAACQHAIRD1GsmxAcAhEPUaybAAAAAJAYIYAAAAAAEAmgAAAAAAAAAAABL+JmZmZmZmaAAAAAAAAAAAAAAAAAAAAAD+JmZmZmZmaAAAAEFJPU0FUIFNvZnQgWC1SYXkAAAABbT41TOHhNKWsPkqgGlmBzxg+KqAaYLZ7vQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTMAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltZS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAUTpQGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtf/gAAAAAAAB/+AAAAAAAAH/4AAAAAAAAAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltZQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3o=
Datalink service for ROSAT images. This gives access to images in the +various bands, background maps, and other ancillary data. + +For more detailed information on the various data products, please +refer to http://www.xray.mpe.mpg.de/rosat/archive/docs/rdf.ps.gz
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta new file mode 100644 index 0000000000000000000000000000000000000000..038d2943e66e155a151510b131cf6b5e98fb3a5c GIT binary patch literal 1756 zcmZ`)U2o$=6fHDuLsPab1q6bX!b()>Zeu4-yU?Ntl_V_Pk2Gq+A|W9&wkPpy9ozMc z+on<__61RC-WdK5kG%3H_#K={oTMv39x^j$?!7Z}&pp?_@T_EQ{vHtE4h`>^OSPI4K9+@6=^~>+8~@Bhn$9-33fr7%oXZ)wewotD7kEN z5hYZ~f*S<^bp?w;_!LeOgrwfo_7vxCiiCu`Pm?kYaW)GFN^bV1SZju@xPBU*QBVDf z@SG+WG{K~sP3|{Iis|+)2bLXqoRFs9uc@ut~nm=zlg%!Vr9Sh zEp>`k#o8-YYlnOLhd`dZ=xO^kHwpy}MOlnu_^mavWpBLvn8b0wT%sRlUX?E*L7ad- zx*7)BcWdhFF&;-cKT)VNmW62EML#1#5Z52#sIQ8B7SNCkY5f6moCd-`;0K79a!0OY zG${GOln{Fuxo5@<-?C39Or1Edkn>IwU5%!clw{tX8Lm$Q7(=iffSL79LSq7IvIujx zQLP%4?e6i9t$M|%ZXdUMtU6g;ep9!U|F*w0 zE-63n7j|^LtfnBpOa{o8lB?hA#nEK(MLc?WVpfgExWGlN_Goah=X|+GYlf!@u2|r< zGs0U!vu5CYt5|x@!t`oKGqz4#m&W2w4Xz(eka-1e4z5|eTl8o@Kn?8{okV*sPdqW1 zI3Pt2&4+qt6;%*UY99-bKVO_t8kb1`*}zbfn}_bAGp2>LF(YRNZDy?S#@Og7N#^{l z*l~nP94UEElVVJqUcp3eHEExqiY8v2iCHF5)I&%GcL|F7H`G?&wGJNdt6QiY(`x0w zCfuG`wB?!)db3MfFnbrh0E)N0Xh>KH;FAoW7#Y@gLDI2yE zKs40LZqC&XFcJjO_iSwdS~B6cQ_b&?2-io?YRiHR4cSne;5Hfy76Ee%tl=*U9X+0o)en+OGN&J) z~sCL zl3YX(yi2Z*wY#gsC?az@l7<%{V65Mn1=L`E8dO{AxEg%RQY1wt1RK&Q705)Ecr+%D yCAbR*wqlR#W~8eUUy+28A*M^VOB3yq*W_Mlp^W>1T(@0(hwRyBNZqDRYWxdOz@#Jq literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ new file mode 100644 index 00000000..9fee67c4 --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ @@ -0,0 +1,18 @@ + +Definition and support code for the ObsCore data model and table.{'pos0': <pgsphere Circle Unknown 134. 11. 0.1>, 'BAND0': +2.0664033072200047e-09}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. +The calib_level flag takes the following values: + +=== =========================================================== + 0 Raw Instrumental data requiring instrument-specific tools + 1 Instrumental data processable with standard tools + 2 Calibrated, science-ready data without instrument signature + 3 Enhanced data products (e.g., mosaics) +=== ===========================================================High level scientific classification of the data product, taken from an enumerationAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.AAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6AAAAPlJPU0FUIFBTUENDIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9iazEuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAADLAAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAVgAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTEuZml0cy5negAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAANAAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+SqAaWYHPGH/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQyBST1NBVCBNZWRpdW0gWC1SYXkgMTk5MC0xMC0xOSAwODowNzo1MS41MDAwMTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAAAAAAHpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABgAAAAAAAAAAEBghjXxC0AeQCZ8sX1ml+5AGZmZmZmZmgAAAH5Qb2x5Z29uIElDUlMgMTM1LjQwNDkzMTgyNTkgOC4wNDY4MDY3ODQ4IDEzNS40NzY5MjI2MzE5IDE0LjQxNzQ0MTgzODggMTI4Ljg5ODUwNTQ1MjIgMTQuNDE3NDQ3NzcxNSAxMjguOTcwNDg2OTI5MiA4LjA0NjgxMDA0NzNARoAAAAAAAEDnhurXXzGvQOeG6tdfMa9/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENDAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0BGgAAAAAAAAAAAAAAAAIdodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWUAAAAFaW1hZ2UAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAADwAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazEuZml0cy5negAAAD5ST1NBVCBQU1BDQiBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkzLTA0LTI1IDE3OjI3OjQzLjEyOTk5NgAAAFtpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6AAAAAAAAAHJodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAbAAAAAAAAAABAYJtFRGOCNEAnp9uUMZwPQAERERoDt0UAAAB+UG9seWdvbiBJQ1JTIDEzMy45MzM0MTYyMTA0IDEwLjc2MzU5MDAwMTEgMTMzLjk0MTg3OTk4OTIgMTIuODkyMTI4MzMxOSAxMzEuNzU4Mjc0Mzg1IDEyLjg5MjEyODkyMiAxMzEuNzY2NzM3MDYwNyAxMC43NjM1OTA0OTEyQC4AACGN70FA5/nXSFskwkDn+ddIWyTCf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQgAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ALgAAIY3vQQAAAAAAAAB/aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABHcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAA5Uk9TQVQgUFNQQ0IgUk9TQVQgTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABUAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQiBST1NBVCBNZWRpdW0gWC1SYXkgMTk5My0wNC0yNSAxNzoyNzo0My4xMjk5OTYAAABbaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAAAAAAAByaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAIAAAAAAAAAAAQGCbRURjgjRAJ6fblDGcD0ABEREaA7dFAAAAflBvbHlnb24gSUNSUyAxMzMuOTMzNDE2MjEwNCAxMC43NjM1OTAwMDExIDEzMy45NDE4Nzk5ODkyIDEyLjg5MjEyODMzMTkgMTMxLjc1ODI3NDM4NSAxMi44OTIxMjg5MjIgMTMxLjc2NjczNzA2MDcgMTAuNzYzNTkwNDkxMkAuAAAhje9BQOf510hbJMJA5/nXSFskwn/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0IAAAAAAAACAAAAAAAAAAIA////////////////////////////////QC4AACGN70EAAAAAAAAAf2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWU=
A datalink service accompanying obscore. This will forward to data +collection-specific datalink services if they exist or return +extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta new file mode 100644 index 0000000000000000000000000000000000000000..a5fd051a9852fbe3080ee050b528fa8ac4b10497 GIT binary patch literal 1851 zcmb7FU2o$=6s>6bp{8tGszo4J$*d4+w~gaCX-kVLRFY-c-EJDS1)k6_wkNf>&e-c2 zx6MkG*cU{lc|cmX(PdeMahx6TGp$xmN502n-<%)j{G0{) zXOtH#yI>g>C&l7Hi#ESGsk-*A?OO6O5|RbqGq378cHMSNPAQ-g7b>*|e-B~4I+^yrauWc9V<$-ZhJqWQc^$c;ixaHZWJ?4du;z9dYs47M&XC3mxC0G3sBx`D(j02ZO1?(Qsj)BZlCu1oEG)09; z+H8->FbTApe)9Mf&peB@`Zbg?-K$mu-+oO)JLgd)WD!bvEIYFURwYFAfkBUus)%Un z;wjlBB8H}oMt#{iI@xbNJ#HR8-l)|ZwzE;I;o;b|&%QcnxAtAz+1_qA^}4g;x{l*C zc38#P-MHJW!*{}&0r$fBu)J=FwUC1)6?%roYPImKF%E{tPTK$Os9LkPanp->edBDm z;eFmt?n80>|xSNgs9aP>r&8dnAI7E64%(Q=K)1y52zuHWteuK`ESEdPT zY8uti0Cj(O0!A;?ZyEJlP`{>V91bxNmAln$-R;&iNB?BhV@WR2zXC4Iy&%e + +http://dc.zah.uni-heidelberg.de/taphttps://dc.zah.uni-heidelberg.de/tapGloTS 1.0Obscore-1.1Registry 1.1ADQL2.02.1The Astronomical Data Query Language is the standard IVOA dialect of SQL; it contains a very general SELECT statement as well as some extensions for spherical geometry and higher mathematics.
gavo_apply_pm(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmde DOUBLE PRECISION, epdist DOUBLE PRECISION) -> POINT
Returns a POINT (in the UNDEFINED reference frame) for the position +an object at ra/dec with proper motion pmra/pmde has after epdist years. + +positions must be in degrees, PMs in should be in julian years (i.e., proper +motions are expected in degrees/year). pmra is assumed to contain +cos(delta). + +This function goes through the tangential plane. Since it does not have +information on distance and radial velocity, it cannot reconstruct +the true space motion, and hence its results will degrade over time. + +This function should not be used in new queries; use ivo_epoch_prop +instead.
gavo_getauthority(ivoid TEXT) -> TEXT
returns the authority part of an ivoid (or, more generally a URI). +So, ivo://org.gavo.dc/foo/bar#baz becomes org.gavo.dc. + +The behaviour for anything that's not a full URI is undefined.
gavo_ipix(long REAL, lat REAL) -> BIGINT
gavo_ipix returns the q3c ipix for a long/lat pair (it simply wraps +the 13c_ang2ipix function). + +This is probably only relevant when you play tricks with indices or +PPMXL ids.
gavo_match(pattern TEXT, string TEXT) -> INTEGER
gavo_match returns 1 if the POSIX regular expression pattern +matches anything in string, 0 otherwise.
gavo_mocintersect(moc1 MOC, moc2 MOC) -> MOC
returns the intersection of two MOCs.
gavo_mocunion(moc1 MOC, moc2 MOC) -> MOC
returns the union of two MOCs.
gavo_specconv(expr DOUBLE PRECISION, dest_unit TEXT) -> DOUBLE PRECISION
returns the spectral value expr converted to dest_unit. + +expr has to be in either energy, wavelength, or frequency, and dest_unit +must be a VOUnit giving another spectral unit (e.g., MHz, keV, nm, or +Angstrom). This is intended to let users express spectral constraints +in their preferred unit independently of the choice of unit in the +database. Examples:: + + gavo_specconv(obscore.em_min, "keV") > 300 + gavo_specconv(obscore.em_max, "MHz") > 30 + gavo_specconv(spectral_start, "Angstrom") > 4000 + +There is a variant of gavo_specconv accepting expr's unit in a third +argument.
gavo_specconv(expr NUMERIC, expr_unit TEXT, dest_unit TEXT) -> NUMERIC
returns expr assumed to be in expr_unit expressed in dest_unit. + + This is a variant of the two-argument gavo_specconv for when + the unit of expr is not known to the ADQL translator, either because + it because it is a literal or because it does not look like + a spectral unit. Examples:: + + gavo_specconv(656, 'nm', 'J') BETWEEN spectral_start AND spectral_end + gavo_specconv(arccos(phi)*incidence, 'Hz', 'eV') + + Clearly, overriding known units is likely to yield bad results; + the translator therefore warns if an existing unit is overridden + with a different unit.
gavo_vocmatch(vocname TEXT, term TEXT, matchagainst TEXT) -> INTEGER
returns 1 if matchagainst is term or narrower in the IVOA vocabulary +vocname, 0 otherwise. + +This is intended for semantic querying. For instance, +gavo_vocmatch('datalink/core', 'calibration', semantics) would be 1 +if semantics is any of calibration, bias, dark, or flat. + +For RDF-flavoured vocabularies (strict trees), term will expand to the +entire branch rooted in term. For SKOS-flavoured vocabularies (where +narrower is not transitive), only directly narrower terms will be included. + +Both the term and the vocabulary name must be string literals (i.e., +constants). matchagainst can be any string-valued expression.
ivo_epoch_prop(ra DOUBLE PRECISION, dec DOUBLE PRECISION, parallax DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, radial_velocity DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> DOUBLE PRECISION[6]
Returns a 6-vector of (ra, dec, parallax, pmra, pmdec, rv) +at out_epoch for these quantities at ref_epoch. + +Essentially, it will apply the proper motion under the assumption of +linear motion. Despite the name of the positional parameters, this is +not restricted to equatorial systems, as long as positions and proper +motions are expressed in the same reference frames. + +Units on input and output are degrees for ra and dec, mas for parallax, +mas/yr for pmra and pmdec, and km/s for the radial velocity. + +ref_epoch and out_epoch are given in Julian years. + +parallax, pmra, pmdec, and radial_velocity may be None and will enter +the computations as 0 then, except in the case of parallax, which +will be some small value. When abs(parallax) is smaller or equal +to that small value, parallax and radial velocity will be NULL on +output. + +In daily use, you probably want to use the ivo_epoch_prop_pos functions.
ivo_epoch_prop_pos(ra DOUBLE PRECISION, dec DOUBLE PRECISION, parallax DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, radial_velocity DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> POINT
Returns a POINT giving the position at out_epoch for an object +with the six parameters at ref_epoch. + +Essentially, it will apply the proper motion under the assumption of +linear motion. Despite the name of the positional parameters, this is +not restricted to equatorial systems, as long as positions and proper +motions are expressed in the same reference frames. + +Units on input are degrees for ra and dec, mas for parallax, +mas/yr for pmra and pmdec, and km/s for the radial velocity. +ref_epoch and out_epoch are given in Julian years. + +parallax, pmra, pmdec, and radial_velocity may be None and will enter +the computations as 0 then, except in the case of parallax, which +will be some small value.
ivo_epoch_prop_pos(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> POINT
A variant of ivo_epoch_prop_pos that behave as if parallax + and radial_velocity were both passed as NULL.
ivo_geom_transform(from_sys TEXT, to_sys TEXT, geo GEOMETRY) -> GEOMETRY
The function transforms ADQL geometries between various reference systems. +geo can be a POINT, a CIRCLE, or a POLYGON, and the function will return a +geometry of the same type. In the current implementation, from_sys and +to_sys must be literal strings (i.e., they cannot be computed through +expressions or be taken from database columns). + +All transforms are just simple rotations, which is only a rough +approximation to the actual relationships between reference systems +(in particular between FK4 and ICRS-based ones). Note that, in particular, +the epoch is not changed (i.e., no proper motions are applied). + +We currently support the following reference frames: ICRS, FK5 (which +is treated as ICRS), FK4 (for B1950. without epoch-dependent corrections), +GALACTIC. Reference frame names are case-sensitive.
ivo_hashlist_has(hashlist TEXT, item TEXT) -> INTEGER
The function takes two strings; the first is a list of words not +containing the hash sign (#), concatenated by hash signs, the second is +a word not containing the hash sign. It returns 1 if, compared +case-insensitively, the second argument is in the list of words coded in +the first argument. The behaviour in case the the second +argument contains a hash sign is unspecified.
ivo_hasword(haystack TEXT, needle TEXT) -> INTEGER
gavo_hasword returns 1 if needle shows up in haystack, 0 otherwise. This +is for "google-like"-searches in text-like fields. In word, you can +actually employ a fairly complex query language; see +https://www.postgresql.org/docs/current/textsearch.html +for details.
ivo_healpix_center(hpxOrder INTEGER, hpxIndex BIGINT) -> POINT
returns a POINT corresponding to the center of the healpix with +the given index at the given order.
ivo_healpix_index(order INTEGER, ra DOUBLE PRECISION, dec DOUBLE PRECISION) -> BIGINT
Returns the index of the (nest) healpix with order containing the +spherical point (ra, dec). + +An alternative, 2-argument form + +ivo_healpix_index(order INTEGER, p POINT) -> BIGINT + +is also available.
ivo_histogram(val REAL, lower REAL, upper REAL, nbins INTEGER) -> INTEGER[]
The aggregate function returns a histogram of val with nbins+2 elements. +Assuming 0-based arrays, result[0] contains the number of underflows (i.e., +val<lower), result[nbins+1] the number of overflows. Elements 1..nbins +are the counts in nbins bins of width (upper-lower)/nbins. Clients +will have to convert back to physical units using some external +communication, there currently is no (meta-) data as lower and upper in +the TAP response.
ivo_interval_has(val NUMERIC, iv INTERVAL) -> INTEGER
The function returns 1 if the interval iv contains val, 0 otherwise. +The lower limit is always included in iv, behaviour on the upper +limit is column-specific.
ivo_interval_overlaps(l1 NUMERIC, h1 NUMERIC, l2 NUMERIC, h2 NUMERIC) -> INTEGER
The function returns 1 if the interval [l1...h1] overlaps with +the interval [l2...h2]. For the purposes of this function, +the case l1=h2 or l2=h1 is treated as overlap. The function +returns 0 for non-overlapping intervals.
ivo_nocasematch(value TEXT, pattern TEXT) -> INTEGER
ivo_nocasematch returns 1 if pattern matches value, 0 otherwise. +pattern is defined as for the SQL LIKE operator, but the +match is performed case-insensitively. This function in effect +provides a surrogate for the ILIKE SQL operator that is missing from +ADQL. + +On this site, this is actually implemented using python's and SQL's +LOWER, so for everything except ASCII, your mileage will vary.
ivo_normal_random(mu REAL, sigma REAL) -> REAL
The function returns a random number drawn from a normal distribution +with mean mu and width sigma. + +Implementation note: Right now, the Gaussian is approximated by +summing up and scaling ten calls to random. This, hence, is not +very precise or fast. It might work for some use cases, and we +will provide a better implementation if this proves inadequate.
ivo_simbadpoint(identifier TEXT) -> POINT
gavo_simbadpoint queries simbad for an identifier and returns the +corresponding point. Note that identifier can only be a literal, +i.e., as simple string rather than a column name. This is because +our database cannot query simbad, and we probably wouldn't want +to fire off millions of simbad queries anyway; use simbad's own +TAP service for this kind of application.
ivo_string_agg(expression TEXT, delimiter TEXT) -> TEXT
An aggregate function returning all values of +expression within a GROUP contcatenated with delimiter
ivo_to_jd(d TIMESTAMP) -> DOUBLE PRECISION
The function converts a postgres timestamp to julian date. +This is naive; no corrections for timezones, let alone time +scales or the like are done; you can thus not expect this to be +good to second-precision unless you are careful in the construction +of the timestamp.
ivo_to_mjd(d TIMESTAMP) -> DOUBLE PRECISION
The function converts a postgres timestamp to modified julian date. +This is naive; no corrections for timezones, let alone time +scales or the like are done; you can thus not expect this to be +good to second-precision unless you are careful in the construction +of the timestamp.
BOX
POINT
CIRCLE
POLYGON
REGION
CENTROID
COORD1
COORD2
DISTANCE
CONTAINS
INTERSECTS
AREA
LOWER
ILIKE
OFFSET
CAST
IN_UNIT
WITH
TABLESAMPLE
Written after a table reference, TABLESAMPLE(10) will make the database only use 10% of the rows; these are `somewhat random' in that the system will use random blocks. This should be good enough when just testing queries (and much better than using TOP n).
MOC
A geometry function creating MOCs. It either takes a string argument with an ASCII MOC ('4/13 17-18 8/3002'), or an order and another geometry.
COALESCE
This is the standard SQL COALESCE for providing defaults in case of NULL values.
VECTORMATH
You can compute with vectors here. See https://wiki.ivoa.net/twiki/bin/view/IVOA/ADQLVectorMath for an overview of the functions and operators available.
CASE
The SQL92 CASE expression
UNION
EXCEPT
INTERSECT
text/tab-separated-valuestsvtext/plaintxttext/csvcsv_baretext/csv;header=presentcsvapplication/jsonjsonapplication/geo+jsongeojsonapplication/x-votable+xmlvotableapplication/x-votable+xml;serialization=BINARY2votable/b2votableb2application/x-votable+xml;serialization=TABLEDATAtext/xmlvotable/tdvotabletdapplication/x-votable+xml;serialization=TABLEDATA;version=1.1text/xmlvotabletd1.1application/x-votable+xml;version=1.1text/xmlvotable1.1application/x-votable+xml;serialization=TABLEDATA;version=1.2text/xmlvotabletd1.2application/x-votable+xml;serialization=TABLEDATA;version=1.5vodmlapplication/x-votable+xml;version=1.5vodmlbtext/htmlhtmlapplication/fitsfits17280072002000016000000100000000
http://dc.zah.uni-heidelberg.de/__system__/tap/run/availabilityhttps://dc.zah.uni-heidelberg.de/__system__/tap/run/availabilityhttp://dc.zah.uni-heidelberg.de/__system__/tap/run/capabilitieshttps://dc.zah.uni-heidelberg.de/__system__/tap/run/capabilitieshttp://dc.zah.uni-heidelberg.de/__system__/tap/run/tableMetadatahttps://dc.zah.uni-heidelberg.de/__system__/tap/run/tableMetadatahttp://dc.zah.uni-heidelberg.de/__system__/tap/run/exampleshttps://dc.zah.uni-heidelberg.de/__system__/tap/run/examples
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta new file mode 100644 index 0000000000000000000000000000000000000000..d978c1a5e562b37e76ea5e370dd217a4cc2f09d0 GIT binary patch literal 1504 zcmZWp&2A$_5ROA3R;vRn^_!S6}^F`17C5jm7WA?CY{rRHc&m zJOK0ZZ(R(51|X!-djj62AeD5a5~;6J0oHp;C49#uFd3<60=>vr<_~l5-rN|yMWo^a zj4t~;j=@(EXP8qy7g!R4W$Xo>yQ>6catNXh49||($mre6rSJL5SM;}}Cz>FHt)u+bkap(bPQUpp)R9=XUkIQQNn znghXS^Cj5(xJ#p8F>)16T%RV?i(=#&*$+PmHy2EYrLcTpY1~eclR6#YqmABvV~vx{_#&DA zaPBspXHEcDx8r@;fwmJ^+#4+XB)X;SxcgU%&d)TfTT`i?B<-A z63T&J+ZXHV3fYxwH-}W7E`nZAu?DwD5*|nX+~|iEQ721!iy?Zi2Sb|1D$5#VVYzaU zOa@9K*kFFg#u)mo?z1Cviz38jv(Y6~l2t@s?}SkR`6XKz_903Xg-8NErV&HOC%Gf9 zL{f&riG~sNVtc~J`8JdHcW!lcy^|MvxuHK@J0&O*F>D7K<7sh>FT2%`?(Zj5h3KtH z@NsC6L~zA%ARwBX78LwGm`Z6$sS+>7j)x$>xikmpqjAiqcYJ+aAdFAViy!~}3sNua z-I(y_+|UJ&2XoWM(#VFiQ>cW4D#5`6<|iZdLt+Dv7CWyvGyT*<<&3HFLmVZ2T_z|1 zf>KeEpk&dABhNt_^L2S(zZW2pHzavq7wiKt?5<95aQ$B@dc%ZCm?-leUrXL)7b7Yf z15Xtmo4*nz97F=!QlhU&79`DW3*aQh=`zOUCh + +amandaAMANDA-II neutrino candidatesA list of neutrino candidate events recorded by the AMANDA-II neutrino +telescope during the period 2000-2006.amanda.nucand Detection parameters of neutrino candidates recorded by the AMANDA-II +telescope. This table can be queried on the web at +http://dc.g-vo.org/amanda/q/web6595idArtifical primary key.meta.id;meta.maincharindexedprimaryraj2000Neutrino arrival direction, RAdegpos.eq.ra;meta.mainfloatindexeddej2000Neutrino arrival direction, Declinationdegpos.eq.dec;meta.mainfloatindexednchNumber of optical modules hit in an eventmeta.numbershortang_errorAngular resolution of a neutrino eventdegpos.angResolutionfloatmjdObservation time, Modified Julian Daydtime.epoch;obsfloatatmonusubsetSubset of candidates used in AMANDA's seven-year atmospheric neutrino analysismeta.codebooleanorigin_estA circle around the most likely position with ang_error radius (for convenient matching).pos.outline;obs.fielddoublenullable
annisredStripe 82 Photometric Redshifts from SDSS Coadditions This survey gives photometric redshifts of objects within 275 deg² +(−50◦ < α < 60◦ and −1.◦25 < δ < +1.◦25) centered on the Celestial +Equator. Each piece of sky has ∼20 runs of repeated scanning by the +SDSS camera contributing and thus reaches ∼2 mag fainter than the SDSS +single pass data, i.e., to r ∼ 23.5 for galaxies.annisred.main This survey gives photometric redshifts of objects within 275 deg² +(−50◦ < α < 60◦ and −1.◦25 < δ < +1.◦25) centered on the Celestial +Equator. Each piece of sky has ∼20 runs of repeated scanning by the +SDSS camera contributing and thus reaches ∼2 mag fainter than the SDSS +single pass data, i.e., to r ∼ 23.5 for galaxies.14000000objidUnique SDSS identifier.meta.id;meta.mainlongindexedrunRun numbermeta.id;obsshortrerunRerun numbermeta.id;obsshortcamcolCamera columnmeta.id;instrshortfieldidField numbermeta.id;obs.fieldlongobjThe object id within a field. Usually changes between reruns of the same field.meta.idshortraj2000Right ascension of the object.degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of the object.degpos.eq.dec;meta.maindoubleindexednullablezphotPhotometric redshift from SDSS' PHOTO pipelinefloatindexednullablezphoterrError in the photometric redshift from SDSS' PHOTO pipelinefloatnullable
antares2007-2012 ANTARES search for cosmic neutrino point sources A time integrated search for point sources of cosmic neutrinos was +performed using the data collected from January 2007 to November 2012 +by the ANTARES neutrino telescope. This dataset includes a total of +5921 events obtained during the effective livetime of 1338 days.antares.data A time integrated search for point sources of cosmic neutrinos was +performed using the data collected from January 2007 to November 2012 +by the ANTARES neutrino telescope. This dataset includes a total of +5921 events obtained during the effective livetime of 1338 days.5921idIdentifier for this neutrino.meta.id;meta.maincharindexedprimaryraj2000Right Ascension, ICRSdegpos.eq.ra;meta.mainfloatnullabledej2000Declination, ICRSdegpos.eq.dec;meta.mainfloatnullablen_hitsNumber of signals from the photo multiplier tubes contributing to this observation.meta.number;obsshortang_error1 sigma confidence radius of the position.degstat.error;posfloatindexednullableepoch_mjdArrival time in UTC TOPOCENTER.dtime.epochdoublenullableorigin_estA circle around the most likely position with ang_error radius (for convenient matching).pos.outline;obs.fielddoubleindexednullable
antares102007-2010 ANTARES search for cosmic neutrino point sources A time integrated search for point sources of cosmic neutrinos was +performed using the data collected from January 2007 to November 2010 +by the ANTARES neutrino telescope. This dataset includes a total of +3058 events obtained during the effective livetime of 813 days. + +This is legacy data. The most recently released data can be found at +ivo://org.gavo.dc/antares/q/cone.antares10.data A time integrated search for point sources of cosmic neutrinos was +performed using the data collected from January 2007 to November 2010 +by the ANTARES neutrino telescope. This dataset includes a total of +3058 events obtained during the effective livetime of 813 days. + +This is legacy data. The most recently released data can be found at +ivo://org.gavo.dc/antares/q/cone.3092idIdentifier for this neutrino.meta.id;meta.maincharindexedprimaryraj2000Right Ascension, ICRSdegpos.eq.ra;meta.mainfloatnullabledej2000Declination, ICRSdegpos.eq.dec;meta.mainfloatnullablen_hitsNumber of signals from the photo multiplier tubes contributing to this observation.meta.number;obsshortang_error1 sigma confidence radius of the position.degstat.error;posfloatindexednullableorigin_estA circle around the most likely position with ang_error radius (for convenient matching).meta.id;obs.fielddoublenullable
apassAAVSO Photometric All Sky Survey (APASS) DR10 +AAVSO Photometric All-Sky Survey (APASS), underway since 2010, +covers the entire sky from 7.5 < V < 16.5 magnitude, and in the BVugrizY +bandpasses. A northern and a southern site are used, each with twin ASA +20cm astrographs and Apogee Aspen CG16m cameras, covering 2.9x2.9 square +degrees with 2.6arcsec pixels. Landolt and SDSS standards are used for +all-sky solutions, with typical 0.02mag calibration errors on the bright +end. + +Data Release 10 is a complete reprocessing of all 500K images taken with +the system, including hundreds of nights not part of DR9. Sextractor is +used for star finding and centroiding; DAOPHOT is used for aperture +photometry; the astrometry.net plate-solving library is used for basic +astrometry, supplanted with more precise WCS that utilizes knowledge of the +optical train distortions. With these changes, DR10 includes many more +stars than prior releases. + +More information is available at http://www.aavso.org/apass.apass.dr10 +AAVSO Photometric All-Sky Survey (APASS), underway since 2010, +covers the entire sky from 7.5 < V < 16.5 magnitude, and in the BVugrizY +bandpasses. A northern and a southern site are used, each with twin ASA +20cm astrographs and Apogee Aspen CG16m cameras, covering 2.9x2.9 square +degrees with 2.6arcsec pixels. Landolt and SDSS standards are used for +all-sky solutions, with typical 0.02mag calibration errors on the bright +end. + +Data Release 10 is a complete reprocessing of all 500K images taken with +the system, including hundreds of nights not part of DR9. Sextractor is +used for star finding and centroiding; DAOPHOT is used for aperture +photometry; the astrometry.net plate-solving library is used for basic +astrometry, supplanted with more precise WCS that utilizes knowledge of the +optical train distortions. With these changes, DR10 includes many more +stars than prior releases. + +More information is available at http://www.aavso.org/apass.130000000idAPASS DR10 identifier formed as (SPD zone)-(star number)meta.id;meta.maincharindexedprimaryraICRS right ascension for this object.pos.eq.ra;meta.maindoubleindexednullabledecICRS declination for this object.pos.eq.dec;meta.maindoubleindexednullablera_errorEstimated error in ra (there will be additional systematics especially in crowded fields).degstat.error;pos.eq.rafloatnullabledec_errorEstimated error in dec (there will be additional systematics especially in crowded fields).degstat.error;pos.eq.decfloatnullablenobs_bNumber of observations that went into mag_bmeta.number;obs;em.opt.Bshortmag_bMagnitude in Johnson B (Vega system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Bfloatnullableerr_mag_bEstimated error in mag_b. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Bfloatnullablenobs_vNumber of observations that went into mag_vmeta.number;obs;em.opt.Vshortmag_vMagnitude in Johnson V (Vega system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Vfloatnullableerr_mag_vEstimated error in mag_v. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Vfloatnullablenobs_uNumber of observations that went into mag_umeta.number;obs;em.opt.Ushortmag_uMagnitude in Sloan u' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ufloatnullableerr_mag_uEstimated error in mag_u. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ufloatnullablenobs_gNumber of observations that went into mag_gmeta.number;obs;em.opt.Vshortmag_gMagnitude in Sloan g' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Vfloatnullableerr_mag_gEstimated error in mag_g. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Vfloatnullablenobs_rNumber of observations that went into mag_rmeta.number;obs;em.opt.Rshortmag_rMagnitude in Sloan r' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Rfloatnullableerr_mag_rEstimated error in mag_r. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Rfloatnullablenobs_iNumber of observations that went into mag_imeta.number;obs;em.opt.Ishortmag_iMagnitude in Sloan i' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ifloatnullableerr_mag_iEstimated error in mag_i. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ifloatnullablenobs_z_sNumber of observations that went into mag_z_smeta.number;obs;em.opt.Ishortmag_z_sMagnitude in Sloan z_s (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ifloatnullableerr_mag_z_sEstimated error in mag_z_s. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ifloatnullablenobs_yNumber of observations that went into mag_ymeta.number;obs;em.opt.Ishortmag_yMagnitude in Sloan Y (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ifloatnullableerr_mag_yEstimated error in mag_y. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ifloatnullable
apoApache Point observations of lensed quasarsObservations of the lensed quasar Q2237+0305 performed between 1995 +and 1998.apo.framesObservations of the lensed quasar Q2237+0305 performed between 1995 +and 1998.527accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullabletypecharnullableobjectcharnullableraw_objectcharnullablefilter1Filters on filter wheel 1charnullablefilter2Filters on filter wheel 2charnullableexposurefloatnullablealpharawRA of center of view 1950.0charnullabledeltarawDec of center of view 1950.0charnullablepub_didPublisher DID for this dataset.charnullable
applauseAPPLAUSE DR3 Plate Scans APPLAUSE DR3 contains images and metadata from 24 plate collections +in Hamburg, Bamberg, Potsdam, Tautenburg and Tartu, a total of 101138 +scans of 70276 photographic plates. The present table contains +metadata records for singly exposed plates with astrometric solutions +in APPLAUSE (about 44000). It is mainly intended as a basis for +publishing suitable APPLAUSE plates in the Obscore schema through the +TAP service in GAVO's Heidelberg Data Center. + +A TAP service with more complete metadata and, in particular, +extracted sources, is available at https://www.plate-archive.org/tap.applause.mainA redux of the calibrated subset of APPLAUSE to the obscore schema, +with constant columns removed.44370obs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharindexednullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoubleindexednullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoubleindexednullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoubleindexednullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoubleindexednullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullablepreviewURL for a preview of the imagemeta.ref.url;meta.previewcharnullableemulsionEmulsion of the original plate (from observatory log).instr.plate.emulsioncharnullablefilterFilter used (from observatory log).meta.id;instr.filter;meta.maincharnullable
arigfhARIGFH object catalogARI's "Geschichte des Fixsternhimmels" is an attempt to collect all +astrometrically useful observations from before ca. 1970 in a way +comparable to what has been done to construct the FK* series of +fundamental catalogs. About 7e6 published positions are included. + +In GAVO's DC, we provide tables of identified and non-identified stars +together with the master catalog that objects were identified against.arigfh.masterThe master catalog against which all ARIGFH historical observations +were matched.612627catnoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintindexedprimaryraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoubleindexednullablepmraMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdeMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecomponentComponent designation in a multiple system in the master catalogmeta.code.multipcharnullable
arigfh.identifiedMatches between the master catalog and the historical catalogs.6300000distOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullablemasternoCatalog number in master catalog (arigfh.master)meta.id;meta.mainintindexeddcompComponent designation for multiple system, as in the master catalogmeta.code.multipcharnullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcsortCatalog typemeta.codeshortcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexedcatanObject number in source catalog, ARI assignedmeta.idintindexed
arigfh.unidentifiedThe objects in the gfh table that could not be matched with objects in +the master catalog by ARIGFH.872720catanObject number in source catalog, ARI assignedmeta.idintindexedcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexed
arigfh.gfhThe table of (almost) all objects read from the catalogs, together +with most of the data given in them.7100000catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharindexednullablecatanObject number in source catalog, ARI assignedmeta.idintindexedcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoubleindexednullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoubleindexednullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.id The stars from the gfh table having counterparts in the master +catalog, together with those counterparts.masternoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintcompmasterComponent designation in a multiple system in the master catalogmeta.code.multipcharnullableraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoublenullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoublenullablepmramasterMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdemasterMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvmasterVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembmasterBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecatidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintdistOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.nid The stars from the gfh table that could not be matched with objects +in the master catalog.catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arihipARIHIP astrometric catalogue The catalogue ARIHIP has been constructed by selecting the 'best +data' for a given star from combinations of HIPPARCOS data with Boss' +GC and/or the Tycho-2 catalogue as well as the FK6. It provides 'best +data' for 90 842 stars with a typical mean error of 0.89 mas/year +(about a factor of 1.3 better than Hipparcos for this sample of +stars).arihip.main The catalogue ARIHIP has been constructed by selecting the 'best +data' for a given star from combinations of HIPPARCOS data with Boss' +GC and/or the Tycho-2 catalogue as well as the FK6. It provides 'best +data' for 90 842 stars with a typical mean error of 0.89 mas/year +(about a factor of 1.3 better than Hipparcos for this sample of +stars).90842hipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997).meta.id;meta.mainintindexedprimarysrcselSource of the astrometric solutionmeta.codecharnullableraj2000Right ascension from a single-star solutiondegpos.eq.ra;meta.maindoubleindexeddej2000Declination from a single-star solutiondegpos.eq.dec;meta.maindoubleindexedpmraProper motion in right ascension times cos(delta) for a single-star solution.deg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in declination for a single-star solution.deg/yrpos.pm;pos.eq.decfloatnullablet_raCentral epoch of RA (SI)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_raError in RA from the single star solution, with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmraMean error in PM(RA)*cos(delta) from the single star solutiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_deCentral epoch of Dec (SI)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_deError in Dec from the single star solutiondegstat.error;pos.eq.decfloatnullableerr_pmdeMean error in PM(Dec) form the single star solutiondeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxParallax used in deriving the data of the star in the catalogue selected for the ARIHIP. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax (see Kp).degpos.parallaxfloatnullablee_parallaxMean error of the parallaxdegstat.error;pos.parallaxfloatnullablekpSource of the parallax: H Hipparcos, P photometric parallaxmeta.ref;pos.parallaxcharnullablevradRadial velocity as used in calculating the foreshortening effect.km/sphys.veloc;pos.heliocentricfloatnullablemvVisual magnitude taken from the HIPPARCOS cataloguemagphot.mag;em.opt.VfloatindexednullablekmVariability flag. See note.meta.code;src.varcharnullablekbinBinarity flag. See note.meta.code.multipcharnullablekdmuBased on Delta mu, 1 is a single-star candidate, 2 is a Delta mu binary, and empty values mean uncertain casesmeta.code.multipcharnullablekaeMeasure of astrometric quality between 1 and 3, higher is better. Empty values mean the star is not 'astrometrically excellent'.meta.code.qualcharnullableraltpRight ascension in LTP modedegpos.eq.radoublenullabledeltpDeclination in LTP modedegpos.eq.decdoublenullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablet_raltpCentral epoch of RA (LTP)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_raltpError in RA (LTP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_deltpCentral epoch of Dec (LTP)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_deltpError in Dec (LTP)degstat.error;pos.eq.decfloatnullableerr_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerastpRight ascension in STP modedegpos.eq.radoublenullabledestpDeclination in STP modedegpos.eq.decdoublenullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablet_rastpCentral epoch of RA (STP)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_rastpError in RA (STP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_destpCentral epoch of Dec (STP)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_destpError in Dec (STP)degstat.error;pos.eq.decfloatnullableerr_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerahipRight ascension in HIP modedegpos.eq.radoublenullabledehipDeclination in HIP modedegpos.eq.decdoublenullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablet_rahipCentral epoch of RA (HIP)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_rahipError in RA (HIP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_dehipCentral epoch of Dec (HIP)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_dehipError in Dec (HIP)degstat.error;pos.eq.decfloatnullableerr_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxsiParallax obtained in solution SIdegpos.parallaxfloatnullableerr_parallaxsiError in parallax obtained in solution SIdegstat.error;pos.parallaxfloatnullableparallaxstpParallax obtained in solution STPdegpos.parallaxfloatnullableerr_parallaxstpError in parallax obtained in solution STPdegstat.error;pos.parallaxfloatnullableparallaxhipParallax obtained in solution HIPdegpos.parallaxfloatnullableerr_parallaxhipError in parallax obtained in solution HIPdegstat.error;pos.parallaxfloatnullableffhF-Measure for proper motions FK5 proper motions vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullableff0hF-Measure for proper motions original catalogue positions vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullableff0gchF-Measure for proper motions GC positions vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullablef0fF-Measure for proper motions FK5 and Hipparcos positions vs. FK5 proper motionsstat.fit.goodness;pos.pm;arith.difffloatnullableft2hF-Measure for proper motions Tycho2 and Hipparcos proper motionsstat.fit.goodness;pos.pm;arith.difffloatnullableflagsBinarity evidence and variability flags (see note)meta.codecharnullable
augerPierre Auger Observatory public dataThis dataset comprises the public data observed by the Pierre Auger +cosmic ray observatory, which is 1% of its total data. It contains +28493 events between 0.1 and 49.7 EeV collected between 2004 and 2013.auger.main Detection parameters of cosmic ray source candidates recorded by the +Pierre Auger Telescope. This table can be queried on the web at +http://dc.g-vo.org/auger/q/cone/form .28493eventidAuger event numbermeta.id;meta.maincharraj2000Incoming cosmic ray direction, RAdegpos.eq.ra;meta.mainfloatdej2000Incoming cosmic ray direction, Declinationdegpos.eq.dec;meta.mainfloatnstatNumber of stations participating in an eventmeta.number;obsshortcreReconstructed energy of the cosmic ray particleEeVphys.energyfloatmjdObservation time, Modified Julian Daytime.epoch;obsfloatgallonGalactic longitudedegpos.galactic.londoublegallatGalactic latitudedegpos.galactic.latdouble
bgdsBochum Galactic Disk Survey BGDS The Bochum Galactic Disk Survey is an ongoing project to monitor the +stellar content of the Galactic disk in a 6 degree wide stripe +centered on the Galactic plane. The data has been recorded since +mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at +the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean +Atacama desert. It contains measurements of about 2x10^7 stars over +more than seven years. Additionally, intermittent measurements in +Johnson UVB and Sloan z have been recorded as well.bgds.phot_all All mean photometry of bgds in one table. It may be simpler to write +queries against the split-band tables phot_band. Measurements in +different fields and bands have not been merged, as that procedure is +too error-prone in crowded milky way regions.band_nameThe band the mean photometry is given for.meta.id;instr.filtercharnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullableerr_magError in mean magnitude in this bandmagstat.error;phot.magfloatnullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablefluxMean flux in this band; this is computed from the mean magnitude based on Landolt standard stars.mJyphot.flux;stat.meanfloatnullableerr_fluxError in mean flux in this bandmJystat.error;phot.fluxfloatnullablenobsNumber of observations in this light curvemeta.number;obsshort
bgds.ssa_time_series This table contains about metadata about the photometric time series +from BGDS in IVOA SSA format. The actual data is available through a +datalink service or in the phot_i and phot_r tables.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullabletime_minFirst timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.mindoublenullabletime_maxLast timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.maxdoublenullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullablefieldSurvey field observed.meta.id;obs.fieldcharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemjdsAn array containing the epochs of the time seriesdtime.epochdoublenullablemagsAn array containing the values of the time series.magphot.magfloatnullable
bgds.data The Bochum Galactic Disk Survey is an ongoing project to monitor the +stellar content of the Galactic disk in a 6 degree wide stripe +centered on the Galactic plane. The data has been recorded since +mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at +the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean +Atacama desert. It contains measurements of about 2x10^7 stars over +more than seven years. Additionally, intermittent measurements in +Johnson UVB and Sloan z have been recorded as well.64413accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldSurvey field observed.meta.id;obs.fieldcharindexednullableexposureEffective exposure time (sum of exposure times of all images contributing here).stime.duration;obs.exposurefloatnullableairmassAirmass at mean epochobs.airMassfloatnullablemoondistMoon distance at mean epochdegobs.paramfloatnullablepub_didDataset identifier assigned by the publishermeta.id;meta.maincharnullable
boydendeBoyden Station ADH Plates in GermanyThe Armagh-Dunsink-Harvard Becker-Schmidt Telescope was deployed at +Boyden Station, Maselspoort South Africa between 1965 and 1970. During +that time, astronomers from Bamberg, Heidelberg, Hamburg and Münster +took astronomical images there, with a focus on old star clusters, the +Magellanic clouds, and the southern milky way. This service provides +scans of the plates obtained.boydende.dataThe Armagh-Dunsink-Harvard Becker-Schmidt Telescope was deployed at +Boyden Station, Maselspoort South Africa between 1965 and 1970. During +that time, astronomers from Bamberg, Heidelberg, Hamburg and Münster +took astronomical images there, with a focus on old star clusters, the +Magellanic clouds, and the southern milky way. This service provides +scans of the plates obtained.244accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableexposureEffective exposure timestime.duration;obs.exposurefloatnullableobjectSpecial object on platemeta.idcharnullablestart_timeStart of exposuredtime.start;obsdoublenullableend_timeEnd of exposuredtime.end;obsdoublenullablewfpdb_idPlate identifier as in the WFPDBmeta.idcharnullablequalityPlate Qualitymeta.notecharnullablefilterFilter used (NULL if clear)meta.id;instr.filtercharnullableemulsionPlate emulsioninstr.plate.emulsioncharnullableobsnotesObservation Notesmeta.notecharnullabledatalink_urlURL to a datalink document for this plate (ancillary files, cutouts)meta.ref.urlcharnullableenvelopePlate envelope with plate metadatameta.ref.urlcharnullablepub_didGlobally unique dataset identifiercharindexednullable
browndwarfsDwarfArchives.org – Photometry, spectroscopy, and astrometry of L, T, +and Y dwarfsA catalogue of brown dwarfs produced by +Gelino et al. The database reflects the state of +http://www.dwarfArchives.org on 2015-09-29.browndwarfs.catA catalogue of brown dwarfs produced by +Gelino et al. The database reflects the state of +http://www.dwarfArchives.org on 2015-09-29.1281designationDesignation, typically from 2MASSmeta.id;meta.maincharnullableraj2000RA J2000.0degpos.eq.ra;meta.mainfloatindexednullabledej2000Dec J2000.0degpos.eq.dec;meta.mainfloatindexednullablejmagMagnitude in the J bandmagphot.mag;em.IR.JfloatnullableerrjmagError in magnitude in the J bandmagstat.error;phot.mag;em.IR.JfloatnullablehmagMagnitude in the H bandmagphot.mag;em.IR.HfloatnullableerrhmagError in magnitude in the H bandmagstat.error;phot.mag;em.IR.HfloatnullablekmagMagnitude in the K bandmagphot.mag;em.IR.KfloatnullableerrkmagError in magnitude in the K bandmagstat.error;phot.mag;em.IR.KfloatnullableparallaxParallax as reported by parallax_paper.degpos.parallaxfloatnullableparallax_errorError in parallax as reported by parallax_paper.degstat.error;pos.parallaxfloatnullableparallax_paperReference to the paper the parallax was taken frommeta.bib;pos.parallaxcharnullablepm_totTotal proper motiondeg/yrpos.pmfloatnullablepm_tot_errError in total proper motion.deg/yrstat.error;pos.pmfloatnullablepm_paPosition angle of proper motiondegpos.posAng;pos.pmfloatnullablepm_pa_errorError in the position angle of the proper motion.degstat.error;pos.posAng;pos.pmfloatnullablepm_paperPaper the proper motion was taken from.meta.bib;pos.pmcharnullablespectral_optSpectral type inferred from observation in visible lightsrc.spType;em.optcharindexednullablest_opt_paperReference to the paper the optical spectral type was taken frommeta.bib;src.spTypecharnullablespectral_irSpectral type inferred from observation in infraredsrc.spType;em.IRcharnullablest_ir_paperReference to the paper the infrared spectral type was taken frommeta.bib;src.spTypecharnullablediscovered_asName the object was discovered as.meta.idcharnullablediscovered_byReference to the paper in which the object was discovered.meta.bibcharnullable
califadr3CALIFA (Calar Alto Legacy Integral Field spectroscopy Area) survey DR3 +The Calar Alto Legacy Integral Field Area (CALIFA) survey provides +spatially resolved spectroscopic information for 667 galaxies, mainly +within the local universe (0.005 < z < 0.03). + +CALIFA data was obtained using the PPAK integral field unit (IFU), with a +hexagonal field-of-view of 1.3 square arcmin, with a 100% covering factor +by adopting a three-pointing dithering scheme. has been taken in two +setups: V500 (6 Å bin size, 646 galaxies) and V1200 (2.3 Å bin size, 484 +galaxies). A final product ("COMBO") combining both data sets, covering +3700-7500 Å at 6 Å bin size, is made availble for 484 galaxies. + +CALIFA is a legacy survey, intended for the community. This is the (final) +Data Release 3.califadr3.spectra Metadata for individual spectra. Note that the spectra result from +reducing a complex dithering scheme and are not independent from one +another.5100000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio at 500 nm (V500 spectra) or 400 nm (V1200 spectra)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoubleindexednullablecalifaidCALIFA id number of the target.meta.idshortindexedprimaryxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedprimaryyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedprimary
califadr3.fluxv500Flux and errors versus position for CALIFA setup v500. Positions are +pixel indices into the CALIFA cubes. The associate positions are in +califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, +yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.fluxv1200Flux and errors versus position for CALIFA setup v1200. Positions are +pixel indices into the CALIFA cubes. The associate positions are in +califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, +yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.fluxposv500 Data cubes of positions and fluxes in the optical for a sample of +galaxies, obtained by the CALIFA project in the v500 setup. + +Note that due to the dithering scheme, the points here do not actually +correspond to raw measurements but instead represent a reduction of +several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.fluxposv1200 Data cubes of positions and fluxes in the optical for a sample of +galaxies, obtained by the CALIFA project in the v1200 setup. + +Note that due to the dithering scheme, the points here do not actually +correspond to raw measurements but instead represent a reduction of +several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.cubes Metadata for the CALIFA data cubes as delivered by the project.1574accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullables_raRight ascension of galaxy center, J2000, from NEDdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDeclination of galaxy center, J2000, from NEDdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullableobs_ext_meanMean atmospheric extinction in V band over all pointings.magobs.atmos.extinction;em.opt.V;stat.meanfloatnullableobs_ext_maxMaximal atmospheric extinction in V band band among all pointings.magobs.atmos.extinction;em.opt.V;stat.maxfloatnullableobs_ext_rmsRMS atmospheric extinction in V band band over all pointingsmagstat.error;obs.atmos.extinction;em.opt.Vfloatnullableflag_obs_extQuality flag for atmospheric extinction in V band (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.atmos.extinction;em.opt.Vshortnullableobs_am_meanMean airmass (secz) over all pointings.magobs.airMass;stat.meanfloatnullableobs_am_maxMaximal airmass (secz) band among all pointings.magobs.airMass;stat.maxfloatnullableobs_am_rmsRMS airmass (secz) band over all pointingsmagstat.error;obs.airMassfloatnullableflag_obs_amQuality flag for airmass (secz) (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.airMassshortnullablered_disp_meanMean spectral dispersion FWHM over all pointings.Angstrominstr.dispersion;stat.meanfloatnullablered_disp_maxMaximal spectral dispersion FWHM band among all pointings.Angstrominstr.dispersion;stat.maxfloatnullablered_disp_rmsRMS spectral dispersion FWHM band over all pointingsAngstromstat.error;instr.dispersionfloatnullableflag_red_dispQuality flag for spectral dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_cdisp_meanMean cross-dispersion FWHM over all pointings.pixinstr.dispersion;stat.meanfloatnullablered_cdisp_maxMaximal cross-dispersion FWHM band among all pointings.pixinstr.dispersion;stat.maxfloatnullablered_cdisp_rmsRMS cross-dispersion FWHM band over all pointingspixstat.error;instr.dispersionfloatnullableflag_red_cdispQuality flag for cross-dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_resskyline_minFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), minimum over all pointingscountstat.fit.residual;spect.line;stat.minfloatnullablered_resskyline_maxFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullablered_rmsresskyline_maxRMS flux residual over all fibers of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullableflag_red_skylinesFlag denoting problems with the sky substractionmeta.code.qualshortnullablered_meanstraylight_maxMaximum of mean straylight intensity over all pointingscountinstr.background;stat.meanfloatnullablered_maxstraylight_maxMaximum of maximum straylight intensity over all pointingscountinstr.background;stat.maxfloatnullablered_rmsstraylight_maxMaximum of RMS straylight intensity over all pointingscountinstr.backgroundfloatnullableflag_red_straylightFlag for critical straylight.meta.code.qualshortnullableobs_skymag_meanMean V band sky surface brightness over all pointings.mag/arcsec**2phot.mag.sb;instr.skyLevel;em.opt.V;stat.meanfloatnullableobs_skymag_rmsRMS of V band sky surface brightness over all pointings.mag/arcsec**2stat.error;phot.mag.sb;instr.skyLevel;em.opt.Vfloatnullableflag_obs_skymagFlag for critical sky surface brightness.meta.code.qualshortnullablered_limsb3-sigma limiting surface brightness in B band in mag.mag/arcsec**2phot.mag.sb;em.opt.B;stat.minfloatnullablered_limsbflux3-sigma limiting surface brightness in B band as flux.erg.cm**-2.s**-1.Angstrom**-1.arcsec**-2floatnullableflag_red_limsbFlag for critical limiting surface brightness sensitivity.meta.code.qualshortnullablered_frac_bigerrFraction of bad pixels (error larger than five times the value) in this cube.instr.det.noise;arith.ratiofloatnullableflag_red_errspecFlag indicating excessive bad pixels.meta.code.qualshortnullablecal_qflux_gAverage flux ratio relative to SDSS g mean over all pointingsphot.flux;em.opt.V;arith.ratiofloatnullablecal_qflux_rAverage flux ratio relative to SDSS r mean over all pointingsphot.flux;em.opt.R;arith.ratiofloatnullablecal_qflux_rmsAverage flux ratio relative to SDSS g and r RMS over all pointingsstat.error;em.opt;arith.ratiofloatnullableflag_cal_specphotoFlag for problems with spectro-photometric calibration.meta.code.qualshortnullablecal_rmsvelmeanRMS of radial velocity residuals of estimates based on 3 or 4 spectral subranges wrt the estimates from the full spectrum.km/sstat.error;instr.calibfloatnullableflag_cal_wlFlag for critical wavelength calibration stability.meta.code.qualshortnullableflag_cal_imgqualFlag for visually evident problems in this cubemeta.code.qualshortnullableflag_cal_specqualFlag for visually evident problems in a 30''-aperture spectrum generated from this cubemeta.code.qualshortnullablecal_flatsdssFlag for visually evident problems in the `SDSS flat' (see source paper); NULL here means: no SDSS flat applied.meta.code.qualshortnullableflag_cal_registrationFlag for visually evident problems in the registration of the synthetic broad-band image with SDSS and related procedures.meta.code.qualshortnullableflag_cal_v1200v500Set if a visual check for the 30''-aperture integrated spectra in V500, V1200, and COMB showed problems.meta.code.qualshortnullableobs_seeing_meanMean FWHM seeing over all pointingsarcsecinstr.obsty.seeing;stat.meanfloatnullableobs_seeing_rmsRMS of FWHM seeing over all pointingsarcsecstat.error;instr.obsty.seeingfloatnullablecal_snr1hlrSignal to noise ratio at the half-light ratio.stat.snrfloatnullablenotesNotesmeta.notecharnullablesetupInstrument setup (V500, V1200, or COMBO)meta.code;instrcharnullable
califadr3.objects Object data for DR3 sample. + +The photometric and derived quantities are from growth curve analysis +of the SDSS images for galaxies from the mother sample +(califaid<1000), from SDSS DR7/12 photometry otherwise.667target_nameObject a targeted observation targetedmeta.id;srcobscore:Target.NamecharnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortraj2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.ra;meta.maindoublenullabledej2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.dec;meta.maindoublenullableredshiftRedshift, from growth curve analysis photometry for mother sample galaxies, from SDSS DR7/12 petrosian photometry otherwise.src.redshiftfloatnullablesdss_zRedshift taken from SDSS DR7src.redshiftfloatnullablemaj_axisApparent isophotal major axis from SDSSarcsecphys.angSize;srcfloatnullablemstarStellar masslog(solMass)phys.massfloatnullablemstar_min3 sigma lower limit of Stellar masslog(solMass)phys.mass;stat.minfloatnullablemstar_max3 sigma upper limit of Stellar masslog(solMass)phys.mass;stat.maxfloatnullablechi2χ² of best fitstat.fit.chi2floatnullablevmax_nocorrSurvey volume for this galaxy from apparent isophotal diameter and measured redshift (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablevmax_denscorrV_max additionally corrected for cosmic variance (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablemaguMagnitude in the u band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ufloatnullableerr_maguError in m_ustat.error;phot.mag;em.opt.Ufloatnullableu_extExtinction in the u bandphys.absorption;em.opt.Ufloatnullableabs_u_min3 sigma lower limit of the absolute magnitude in uphot.mag;em.opt.U;stat.minfloatnullableabs_u_max3 sigma upper limit of the absolute magnitude in uphot.mag;em.opt.U;stat.maxfloatnullablemaggMagnitude in the g band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Vfloatnullableerr_maggError in m_gstat.error;phot.mag;em.opt.Vfloatnullableg_extExtinction in the g bandphys.absorption;em.opt.Vfloatnullableabs_g_min3 sigma lower limit of the absolute magnitude in gphot.mag;em.opt.V;stat.minfloatnullableabs_g_max3 sigma upper limit of the absolute magnitude in gphot.mag;em.opt.V;stat.maxfloatnullablemagrMagnitude in the r band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Rfloatnullableerr_magrError in m_rstat.error;phot.mag;em.opt.Rfloatnullabler_extExtinction in the r bandphys.absorption;em.opt.Rfloatnullableabs_r_min3 sigma lower limit of the absolute magnitude in rphot.mag;em.opt.R;stat.minfloatnullableabs_r_max3 sigma upper limit of the absolute magnitude in rphot.mag;em.opt.R;stat.maxfloatnullablemagiMagnitude in the i band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magiError in m_istat.error;phot.mag;em.opt.Ifloatnullablei_extExtinction in the i bandphys.absorption;em.opt.Ifloatnullableabs_i_min3 sigma lower limit of the absolute magnitude in iphot.mag;em.opt.I;stat.minfloatnullableabs_i_max3 sigma upper limit of the absolute magnitude in iphot.mag;em.opt.I;stat.maxfloatnullablemagzMagnitude in the z band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magzError in m_zstat.error;phot.mag;em.opt.Ifloatnullablez_extExtinction in the z bandphys.absorption;em.opt.Ifloatnullableabs_z_min3 sigma lower limit of the absolute magnitude in zphot.mag;em.opt.I;stat.minfloatnullableabs_z_max3 sigma upper limit of the absolute magnitude in zphot.mag;em.opt.I;stat.maxfloatnullablehubtypMorphological type from CALIFA's own visual classification (see 2014A&A...569A...1W for details). (M) indicates definite merging going on, (m) indicates likely merging, (i) indicates signs of interaction.src.morph.typecharminhubtypEarliest morphological type in CALIFA's estimationsrc.morph.typecharmaxhubtypLatest morphological type in CALIFA's estimationsrc.morph.typecharbarBar strength, A -- strong bar, AB -- intermediate, B -- weak bar; with minimum and maximum estimates.meta.code;src.morphcharnullableflag_release_combCube in setup COMB available?meta.code;meta.datasetshortflag_release_v1200Cube in setup V1200 available?meta.code;meta.datasetshortflag_release_v500Cube in setup V500 available?meta.code;meta.datasetshortaxis_ratiob/a axis ratio of a moment-based anaylsis of the SDSS DR7 images (cf. 2014A&A...569A...1W).phys.angSize;arith.ratiofloatnullableposition_anglePosition angle wrt north.degpos.posAngfloatnullableel_hlrPetrosian half-light radius in r bandarcsecphys.angSize;srcfloatnullablemodmag_rModel magnitude in r bandmagphot.mag;meta.modelledfloatnullablecalifadr3.cubescalifaidcalifaid
carsCARS survey dataImages and data from from the CFHTLS archive research survey, a +multi-band dataset spanning 37 square degrees of sky in high galactic +latitudes.cars.srccatExtracted sources from the CARS survey, comprising positions and +multiband photometry.5200000carsidCARS object IDmeta.id;meta.maincharindexedprimaryseqnrRunning object number (in field)meta.idintraj2000Right ascension of barycenter (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of barycenter (J2000)degpos.eq.dec;meta.maindoubleindexednullablexposObject position on exposure along xpixpos.cartesian.x;instr.detfloatnullableyposObject position on exposure along ypixpos.cartesian.y;instr.detfloatnullablemagautoKron-like elliptical aperture magnitudemagphot.magfloatindexednullablemagerrautoError in Kron-like elliptical aperture magnitudemagstat.error;phot.magfloatnullablemagisouIsophotal magnitude in the u* bandmagphot.mag;em.optfloatnullablemagisoerruRMS error of isophotal magnitude in the u* bandmagstat.error;phot.mag;em.optfloatnullablemagapruFixed aperture magnitude in the u* bandmagphot.mag;em.optfloatnullablemagaprerruRMS error of fixed aperture magnitude in the u* bandmagstat.error;phot.mag;em.optfloatnullablemaglimuLimiting magnitude at object's position in u* bandmagfloatnullablemagisogIsophotal magnitude in the g' bandmagphot.mag;em.optfloatnullablemagisoerrgRMS error of isophotal magnitude in the g' bandmagstat.error;phot.mag;em.optfloatnullablemagaprgFixed aperture magnitude in the g' bandmagphot.mag;em.optfloatnullablemagaprerrgRMS error of fixed aperture magnitude in the g' bandmagstat.error;phot.mag;em.optfloatnullablemaglimgLimiting magnitude at object's position in g' bandmagfloatnullablemagisorIsophotal magnitude in the r' bandmagphot.mag;em.optfloatnullablemagisoerrrRMS error of isophotal magnitude in the r' bandmagstat.error;phot.mag;em.optfloatnullablemagaprrFixed aperture magnitude in the r' bandmagphot.mag;em.optfloatnullablemagaprerrrRMS error of fixed aperture magnitude in the r' bandmagstat.error;phot.mag;em.optfloatnullablemaglimrLimiting magnitude at object's position in r' bandmagfloatnullablemagisoiIsophotal magnitude in the i' bandmagphot.mag;em.optfloatnullablemagisoerriRMS error of isophotal magnitude in the i' bandmagstat.error;phot.mag;em.optfloatnullablemagapriFixed aperture magnitude in the i' bandmagphot.mag;em.optfloatnullablemagaprerriRMS error of fixed aperture magnitude in the i' bandmagstat.error;phot.mag;em.optfloatnullablemaglimiLimiting magnitude at object's position in i' bandmagfloatnullablemagisozIsophotal magnitude in the z' bandmagphot.mag;em.optfloatnullablemagisoerrzRMS error of isophotal magnitude in the z' bandmagstat.error;phot.mag;em.optfloatnullablemagaprzFixed aperture magnitude in the z' bandmagphot.mag;em.optfloatnullablemagaprerrzRMS error of fixed aperture magnitude in the z' bandmagstat.error;phot.mag;em.optfloatnullablemaglimzLimiting magnitude at object's position in z' bandmagfloatnullablefwhmFull width half max assuming a gaussian coredegphys.angSizefloatindexednullablefluxradiusFraction-of-light radiuspixfloatnullablemajoraxisProfile RMS along major axisdegphys.angSize.smajAxisfloatnullableminoraxisProfile RMS along minor axisdegphys.angSize.sminAxisfloatnullablethetaPosition angle (east of north) (J2000)degpos.posAngfloatnullablesgclassS/G classifier output (0..1)src.class.starGalaxyfloatnullableextflagsExtraction FlagsintmaskTrue if object is within an object maskmeta.codebooleanz_bPhotometric redshiftfloatnullablet_bMask valuefloatnullableoddsConfidence parameter for photometric redshiftfloatnullablengoodfiltersNumber of filters with good photometry for BPZmeta.code.qualintnbadfiltersNumber of filters with bad photometry for BPZmeta.code.qualintnfaintfiltersNumber of filters with faint photometry for BPZmeta.code.qualintgoodfiltersFilters with faint photometry for BPZcharnullablebadfiltersFilters with bad photometry for BPZcharnullablefaintfiltersFilters with faint photometry for BPZcharnullablefieldkeyCARS field designationmeta.idcharnullable
cars.images +Metadata for co-added CFHTLS archive images +used for producing the CARS source list (cars.srccat).185accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldkeyCARS field designationmeta.idcharnullablefieldbandkeyCARS field designation plus bandmeta.idcharnullablencombineNumber of individual frames in this stackmeta.numberinttexptimeTotal Exposure Timestime.duration;obs.exposurefloatnullablemagzpAB Magnitude Zeropointmagphot.mag;arith.zpfloatnullablemagzperrEstimated Magnitude Zeropoint Errormagstat.error;phot.mag;arith.zpfloatnullableseeingMeasured image seeingarcsecinstr.obsty.seeingfloatnullableseeingerrMeasured image Seeing errorarcsecstat.error;instr.obsty.seeingfloatnullable
carsarcsGravitational arc candidates in the CFHTLS-Archive-Research Survey +CARS Candidate gravitational arcs in the 37 deg^2 of +CFHTLS-Archive-Research Survey (CARS). The data include their +post-stamp images, astrometry, photometry (u*,g',r',i'), geometric +properties (length, length-to-width ratio, profile curvature, area), +and photometric redshifts. The arc candidates were selected booth with +an automatic arcfinder, based on a tailored image segmentation and a +color selection, and by visually inspecting the survey.carsarcs.metaMagnitudes, redshifts, positions, etc. of the arcs found in CARS. Candidate gravitational arcs in the 37 deg^2 of +CFHTLS-Archive-Research Survey (CARS). The data include their +post-stamp images, astrometry, photometry (u*,g',r',i'), geometric +properties (length, length-to-width ratio, profile curvature, area), +and photometric redshifts. The arc candidates were selected booth with +an automatic arcfinder, based on a tailored image segmentation and a +color selection, and by visually inspecting the survey.90previewPreview imagemeta.ref.urlcharnullablematidIdentification number within carsarcsmeta.id;meta.maincharnullablecarsfieldCARS field identifiermeta.id;obs.fieldcharnullableraj2000Right ascension of the center, ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of the center, ICRSdegpos.eq.dec;meta.maindoubleindexednullablearc_lengthLength of the arc (see paper for construction).degphys.angSize;srcfloatnullablearc_l_wLength to width ratio for the arc (see paper for construction).phys.size;arith.ratiofloatnullablearc_curvCurvature of the arc (see paper for construction).deg**-1src.morph.paramfloatnullablearc_areaArea of the arc (see paper for construction).deg**2phys.angSize;srcfloatnullableuprimearc u' aperture magnitude (based on segmentation)magphot.mag;em.opt.Ufloatnullableerr_uprimeError in u magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Ufloatnullablegprimearc g' aperture magnitude (based on segmentation)magphot.mag;em.opt.Vfloatnullableerr_gprimeError in g magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Vfloatnullablerprimearc r' aperture magnitude (based on segmentation)magphot.mag;em.opt.Rfloatnullableerr_rprimeError in r magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Rfloatnullableiprimearc i' aperture magnitude (based on segmentation)magphot.mag;em.opt.Ifloatnullableerr_iprimeError in i magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Ifloatnullablez_lensPhotometric redshift of the lens (from CARS catalog).src.redshift.photfloatnullablez_lens_err_plusLens photometric redshift 1-sigma error taken from the CARS catalog.stat.error;src.redshift.photfloatnullablez_lens_err_minusLens photometric redshift 1-sigma error taken from the CARS catalog.stat.error;src.redshift.photfloatnullablequal_assQuality assessmentmeta.code.qualshortnullablecatnrCatalog number of previously known arcsmeta.id.crosscharnullableimg_uCARS image in the u band.meta.ref.urlcharnullableimg_gCARS image in the g band.meta.ref.urlcharnullableimg_rCARS image in the r band.meta.ref.urlcharnullableimg_iCARS image in the i band.meta.ref.urlcharnullable
casa_linesSplatalogue CASA LineTAP +This is a rendering of the `CASA Offline Splatalogue`_ in +a draft LineTAP, mainly intended to enable verification of the standard. +This is not recommended for production yet. In particular, many +InChIs are known wrong, and we have skipped several hundred lines +because we did have no InChIs for their species at all. + +.. _CASA Offline Splatalogue: https://safe.nrao.edu/wiki/bin/view/ALMA/CASA_Offline_Splat_listcasa_lines.line_tap +This is a rendering of the `CASA Offline Splatalogue`_ in +a draft LineTAP, mainly intended to enable verification of the standard. +This is not recommended for production yet. In particular, many +InChIs are known wrong, and we have skipped several hundred lines +because we did have no InChIs for their species at all. + +.. _CASA Offline Splatalogue: https://safe.nrao.edu/wiki/bin/view/ALMA/CASA_Offline_Splat_listivo://ivoa.net/std/linetap#table-1.0333480titleHuman-readable line designation.meta.idcharvacuum_wavelengthVacuum wavelength of the transitionAngstromem.wldoublevacuum_wavelength_errorTotal error in vacuum_wavelengthAngstromstat.error;em.wldoublenullablemethodMethod the wavelength was obtained with (XSAMS controlled vocabulary)meta.code.classcharnullableelementElement name for atomic transitions, NULL otherwise.phys.atmol.elementcharnullableion_chargeTotal charge (ionisation level) of the emitting particle.phys.electChargeintmass_numberNumber of nucleons in the atom or moleculephys.atmol.weightintnullableupper_energyEnergy of the upper stateJphys.energy;phys.atmol.initialdoublenullablelower_energyEnergy of the lower stateJphys.energy;phys.atmol.finaldoublenullableinchiInternational Chemical Identifier InChI.meta.id;phys.atmol;meta.maincharinchikeyThe InChi key (hash) generated from inchi.meta.id;phys.atmolchareinstein_aEinstein A coefficient of the radiative transition.phys.atmol.transProbdoublenullablexsams_uriA URI for a full XSAMS description of this line.meta.refcharnullableline_referenceReference to the source of the line data; this could be a bibcode, a DOI, or a plain URI.meta.refcharnullablenrao_formulaChemical formula in NRAO's argot.meta.id;phys.molcharnullablecommon_nameCommon name of the molecule.meta.id;phys.molcharnullablequantnrResolved Quantum Number as per http://www.cv.nrao.edu/php/splat/QuantumCode.htmlphys.atmol.configurationcharnullabledipole_momentMolecule dipole moment Sij μ²Dfloatnullable
cns5The Fifth Catalogue of Nearby Stars (CNS5) The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most +volume-complete sample of stars in the solar neighbourhood. The CNS5 +is compiled based on trigonometric parallaxes from Gaia EDR3 and +Hipparcos, and supplemented with astrometric data from Spitzer and +ground-based surveys carried out in the infrared. The CNS5 catalogue +is statistically complete down to 19.7 mag in G-band and 11.8 mag in +W1-band absolute magnitudes, corresponding to a spectral type of L8. + +Continuous updates of observational data for nearby stars from all +sources were collected and evaluated. For all known stars in the 25 pc +sphere around the Sun, the best values of positions in space, +velocities, and magnitudes in different filters are presented.cns5.main The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most +volume-complete sample of stars in the solar neighbourhood. The CNS5 +is compiled based on trigonometric parallaxes from Gaia EDR3 and +Hipparcos, and supplemented with astrometric data from Spitzer and +ground-based surveys carried out in the infrared. The CNS5 catalogue +is statistically complete down to 19.7 mag in G-band and 11.8 mag in +W1-band absolute magnitudes, corresponding to a spectral type of L8. + +Continuous updates of observational data for nearby stars from all +sources were collected and evaluated. For all known stars in the 25 pc +sphere around the Sun, the best values of positions in space, +velocities, and magnitudes in different filters are presented.5909cns5_idCNS5 designationmeta.id;meta.mainlonggj_idGliese-Jahreiss numbermeta.id.crosscharnullablecomponent_idSuffix for a component of binary or multiple systemmeta.code.multipcharnullablen_componentsTotal number of components in the systemmeta.numbershortnullableprimary_flagTrue for the primary of a multiple systemmeta.codeshortnullablegj_system_primaryGliese-Jahriess number of the primary component of the systemmeta.id.crosscharnullablegaia_edr3_idSource identifier in Gaia EDR3meta.id.crosslongnullablehip_idHipparcos identifiermeta.id.crossintnullableraRight ascensiondegpos.eq.ra;meta.maindoubleindexednullabledecDeclinationdegpos.eq.dec;meta.maindoubleindexednullableepochReference epoch for coordinatesyrtime.epochdoublenullablecoordinates_bibcodeSource of the positionmeta.bib;pos.eqcharnullableparallaxAbsolute trigonometric parallaxmaspos.parallax.trigdoublenullableparallax_errorError in parallaxmasstat.error;pos.parallax.trigfloatnullableparallax_bibcodeSource of the parallaxmeta.bib;pos.parallax.trigcharnullablepmraProper motion in right ascensionmas/yrpos.pm;pos.eq.radoublenullablepmra_errorError in pmramas/yrstat.error;pos.pm;pos.eq.radoublenullablepmdecProper motion in declinationmas/yrpos.pm;pos.eq.decdoublenullablepmdec_errorError of pmdecmas/yrstat.error;pos.pm;pos.eq.decdoublenullablepm_bibcodeSource of the proper motionmeta.bib;pos.pmcharnullablervSpectroscopic radial velocitykm/sphys.veloc;pos.barycenterdoublenullablerv_errorError in rvkm/sstat.error;phys.veloc;pos.barycenterdoublenullablerv_bibcodeSource of the radial velocitymeta.bib;phys.veloc;pos.barycentercharnullableg_magG band mean magnitude (corrected)magphot.mag;em.optfloatnullableg_mag_errorError in g_magmagstat.error;phot.mag;em.optdoublenullablebp_magGaia eDR3 integrated BP mean magnitudemagphot.mag;em.opt.bfloatnullablebp_mag_errorError in bp_magmagstat.error;phot.mag;em.opt.bdoublenullablerp_magGaia eDR3 integrated RP mean magnitudemagphot.mag;em.opt.rfloatnullablerp_mag_errorError in rp_magmagstat.error;phot.mag;em.opt.rdoublenullableg_mag_from_hipHipparcos Hp magnitude converted to the G bandmagphot.mag;em.optdoublenullableg_mag_from_hip_errorError in g_mag_from_hipmagstat.error;phot.mag;em.optdoublenullableg_rp_from_hipG - RP colour computed from Hipparcos V and Imagphot.color;em.opt.r;em.optdoublenullableg_rp_from_hip_errorError in g_rp_from_hipmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_mag_resultingResulting (e.g., deblended) G band magnitudemagphot.mag;em.optfloatnullableg_mag_resulting_errorError in g_mag_resultingmagstat.error;phot.mag;em.optdoublenullableg_rp_resultingResulting (e.g., deblended) G - RP colourmagphot.color;em.opt.r;em.optdoublenullableg_rp_resulting_errorError in g_rp_resultingmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_rp_resulting_flag0 – G-RP is deblended; 1 – G-RP is uncorrected vs. eDR3; 2 – G-RP is converted from Hipparcosmeta.code;phot.magshortnullablej_mag2MASS J band magnitudemagphot.mag;em.ir.jfloatnullablej_mag_errorError in j_magmagstat.error;phot.mag;em.ir.jfloatnullableh_mag2MASS H band magnitudemagphot.mag;em.ir.hfloatnullableh_mag_errorError in h_magmagstat.error;phot.mag;em.ir.hfloatnullablek_mag2MASS Ks band magnitudemagphot.mag;em.ir.kfloatnullablek_mag_errorError in k_magmagstat.error;phot.mag;em.ir.kfloatnullablejhk_mag_bibcodeSource of NIR magnitudesmeta.bib;phot.mag;em.ircharnullablew1_magWISE W1 band magnitudemagphot.mag;em.ir.3-4umfloatnullablew1_mag_errorError in w1_magmagstat.error;phot.mag;em.ir.3-4umfloatnullablew2_magWISE W2 band magnitudemagphot.mag;em.ir.4-8umfloatnullablew2_mag_errorError in w2_magmagstat.error;phot.mag;em.ir.4-8umfloatnullablew3_magWISE W3 band magnitudemagphot.mag;em.ir.8-15umfloatnullablew3_mag_errorError in w3_magmagstat.error;phot.mag;em.ir.8-15umfloatnullablew4_magWISE W4 band magnitudemagphot.mag;em.ir.15-30umfloatnullablew4_mag_errorError in w4_magmagstat.error;phot.mag;em.ir.15-30umfloatnullablewise_mag_bibcodeSource of MIR magnitudesmeta.bib;phot.mag;em.ircharnullable
cns5updateThe Fifth Catalogue of Nearby Stars: Continuously Updated Version +(CNS5-updated) +The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most +volume-complete sample of stars in the solar neighbourhood. This is +a continuously-updated version of the published CNS5 +(:bibcode:`2023A&A...670A..19G`). + +The CNS5 is compiled based on trigonometric parallaxes from Gaia DR3 and +Hipparcos, and supplemented with astrometric data from Spitzer and +ground-based surveys carried out in the infrared. The CNS5 catalogue is +statistically complete down to 19.7 mag in G-band and 11.8 mag in W1-band +absolute magnitudes, corresponding to a spectral type of L8. + +Continuous updates of observational data for nearby stars from all sources +were collected and evaluated. For all known stars in the 25 pc sphere +around the Sun, the best values of positions in space, velocities, and +magnitudes in different filters are presented.cns5update.main +The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most +volume-complete sample of stars in the solar neighbourhood. This is +a continuously-updated version of the published CNS5 +(:bibcode:`2023A&A...670A..19G`). + +The CNS5 is compiled based on trigonometric parallaxes from Gaia DR3 and +Hipparcos, and supplemented with astrometric data from Spitzer and +ground-based surveys carried out in the infrared. The CNS5 catalogue is +statistically complete down to 19.7 mag in G-band and 11.8 mag in W1-band +absolute magnitudes, corresponding to a spectral type of L8. + +Continuous updates of observational data for nearby stars from all sources +were collected and evaluated. For all known stars in the 25 pc sphere +around the Sun, the best values of positions in space, velocities, and +magnitudes in different filters are presented.5912cns5_idCNS5 designationmeta.id;meta.mainlonggj_idGliese-Jahreiss numbermeta.id.crosscharnullablecomponent_idDesignation of component(s) in binaries or multiple systems. This may consist of several letters if a catalogue entry corresponds to more than one component that is not split into individual entries.meta.code.multipcharnullablen_componentsTotal number of components in the systemmeta.numbershortnullableprimary_flagTrue for the primary of a multiple systemmeta.codeshortnullablegj_system_primaryGliese-Jahriess number of the primary component of the systemmeta.id.crosscharnullablegaia_dr3_idSource identifier in Gaia DR3meta.id.crosslongnullablehip_idHipparcos identifiermeta.id.crossintnullableraRight ascensiondegpos.eq.ra;meta.maindoublenullabledecDeclinationdegpos.eq.dec;meta.maindoublenullableepochReference epoch for coordinatesyrtime.epochdoublenullablecoordinates_bibcodeSource of the positionmeta.bib;pos.eqcharnullableparallaxAbsolute trigonometric parallaxmaspos.parallax.trigdoublenullableparallax_errorError in parallaxmasstat.error;pos.parallax.trigfloatnullableparallax_bibcodeSource of the parallaxmeta.bib;pos.parallax.trigcharnullablepmraProper motion in right ascensionmas/yrpos.pm;pos.eq.radoublenullablepmra_errorError in pmramas/yrstat.error;pos.pm;pos.eq.radoublenullablepmdecProper motion in declinationmas/yrpos.pm;pos.eq.decdoublenullablepmdec_errorError of pmdecmas/yrstat.error;pos.pm;pos.eq.decdoublenullablepm_bibcodeSource of the proper motionmeta.bib;pos.pmcharnullablervSpectroscopic radial velocitykm/sphys.veloc;pos.barycenterdoublenullablerv_errorError in rvkm/sstat.error;phys.veloc;pos.barycenterdoublenullablerv_bibcodeSource of the radial velocitymeta.bib;phys.veloc;pos.barycentercharnullableg_magG band mean magnitude (corrected)magphot.mag;em.optfloatnullableg_mag_errorError in g_magmagstat.error;phot.mag;em.optdoublenullablebp_magGaia DR3 integrated BP mean magnitudemagphot.mag;em.opt.bfloatnullablebp_mag_errorError in bp_magmagstat.error;phot.mag;em.opt.bdoublenullablerp_magGaia DR3 integrated RP mean magnitudemagphot.mag;em.opt.rfloatnullablerp_mag_errorError in rp_magmagstat.error;phot.mag;em.opt.rdoublenullableg_mag_from_hipHipparcos Hp magnitude converted to the G bandmagphot.mag;em.optdoublenullableg_mag_from_hip_errorError in g_mag_from_hipmagstat.error;phot.mag;em.optdoublenullableg_rp_from_hipG - RP colour computed from Hipparcos V and Imagphot.color;em.opt.r;em.optdoublenullableg_rp_from_hip_errorError in g_rp_from_hipmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_mag_resultingResulting (e.g., deblended) G band magnitudemagphot.mag;em.optfloatnullableg_mag_resulting_errorError in g_mag_resultingmagstat.error;phot.mag;em.optdoublenullableg_rp_resultingResulting (e.g., deblended) G - RP colourmagphot.color;em.opt.r;em.optdoublenullableg_rp_resulting_errorError in g_rp_resultingmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_rp_resulting_flag0 – G-RP is deblended; 1 – G-RP is uncorrected vs. DR3; 2 – G-RP is converted from Hipparcosmeta.code;phot.magshortnullablej_mag2MASS J band magnitudemagphot.mag;em.ir.jfloatnullablej_mag_errorError in j_magmagstat.error;phot.mag;em.ir.jfloatnullableh_mag2MASS H band magnitudemagphot.mag;em.ir.hfloatnullableh_mag_errorError in h_magmagstat.error;phot.mag;em.ir.hfloatnullablek_mag2MASS Ks band magnitudemagphot.mag;em.ir.kfloatnullablek_mag_errorError in k_magmagstat.error;phot.mag;em.ir.kfloatnullablejhk_mag_bibcodeSource of NIR magnitudesmeta.bib;phot.mag;em.ircharnullablew1_magWISE W1 band magnitudemagphot.mag;em.ir.3-4umfloatnullablew1_mag_errorError in w1_magmagstat.error;phot.mag;em.ir.3-4umfloatnullablew2_magWISE W2 band magnitudemagphot.mag;em.ir.4-8umfloatnullablew2_mag_errorError in w2_magmagstat.error;phot.mag;em.ir.4-8umfloatnullablew3_magWISE W3 band magnitudemagphot.mag;em.ir.8-15umfloatnullablew3_mag_errorError in w3_magmagstat.error;phot.mag;em.ir.8-15umfloatnullablew4_magWISE W4 band magnitudemagphot.mag;em.ir.15-30umfloatnullablew4_mag_errorError in w4_magmagstat.error;phot.mag;em.ir.15-30umfloatnullablewise_mag_bibcodeSource of MIR magnitudesmeta.bib;phot.mag;em.ircharnullable
cs82morphozPhotometric redshifts in Stripe 82 This is a catalogue of photometric redshifts of galaxies in the +Stripe 82 obtained when morphology (galaxy size, ellipticity, Sérsic +index, and surface brightness) are included in training on galaxy +samples from the SDSS and the CFHT Stripe-82 Survey (CS82). Our +redshifts yield a 68th percentile error of 0.058(1 + z), and a outlier +fraction of 5.2 per cent.cs82morphoz.main This is a catalogue of photometric redshifts of galaxies in the +Stripe 82 obtained when morphology (galaxy size, ellipticity, Sérsic +index, and surface brightness) are included in training on galaxy +samples from the SDSS and the CFHT Stripe-82 Survey (CS82). Our +redshifts yield a 68th percentile error of 0.058(1 + z), and a outlier +fraction of 5.2 per cent.5800000objid_cs82Identifier built as im_num*1000000+se_idmeta.id;meta.mainintindexedprimaryraICRS Right Ascensiondegpos.eq.ra;meta.maindoubleindexednullabledecICRS Declinationdegpos.eq.dec;meta.maindoubleindexednullableflagsSource extraction quality flag (ranges from 0 to 3, with 0 being the best)meta.codeshortweightlensFit shape measurement confidence. weight>0 indicates good shape measurementstat.weightfloatnullablefitclasslensFit star-galaxy classifier: 1=stars; 0=galaxies; -1=no usable data; -2=blended objects; -3=miscellaneous reasons; -4=chi-square exceeded critical valuemeta.code;src.classshortmag_autoCS82 Kron i-band magnitudemagphot.mag;em.opt.ifloatindexednullablemagerr_autoCS82 Kron i-band magnitude error. Signal-to-noise ratio is 1.086/MAGERR_AUTOmagstat.error;phot.mag;em.opt.ifloatnullablemag_expCS82 exponential fit i-band magnitudemagphot.mag;em.opt.ifloatnullablemag_psfCS82 PSF i-band magnitudemagphot.mag;em.opt.ifloatnullablereff_expExponential fit effective radiusarcsecphys.angsize;srcfloatnullableaspect_expExponential fit axis-ratiosrc.morph.paramfloatnullablemu_mean_expExponential fit mean surface brightnessmag/arcsec**2phot.mag.sb;em.opt.ifloatnullablep_expExponential shape probability: ~1 -> disc galaxy; ~0 -> elliptical galaxystat.fit.goodnessfloatnullablen_serSersic indexstat.fit.paramfloatnullablespread_model_serSersic spread model, the star-galaxy separator we used for this study. All objects in this catalogue have SPREAD_MODEL_SER>0.008, which are considered extended objects (galaxies).stat.fit.paramfloatnullablelensLensing tag. Objects with lens=1 are objects from the lensing subsample (fitclass=0, weight>0)meta.codeshortobjid_sdssSDSS object ID for objects with matched ugriz broadband magnitudes (if available)meta.id.crosslongnullablemag_dered_uSDSS dereddened u-band magnitudemagphot.mag;em.opt.Ufloatnullablemag_dered_gSDSS dereddened g-band magnitudemagphot.mag;em.opt.Vfloatnullablemag_dered_rSDSS dereddened r-band magnitudemagphot.mag;em.opt.Rfloatnullablemag_dered_iSDSS dereddened i-band magnitudemagphot.mag;em.opt.Ifloatnullablemag_dered_zSDSS dereddened z-band magnitudemagphot.mag;em.opt.IfloatnullablezspecSpectroscopic redshift from source given in source_specsrc.redshiftfloatnullablezphotPhotometric redshift estimated using inputs ugriz+morphologysrc.redshiftfloatnullablezmorphPhotometric redshift estimated using inputs i+morphologysrc.redshiftfloatnullablezbestBest redshift for this object, in order of priority: zspec, zphot, zmorphsrc.redshiftfloatindexednullableodds_photOdds value for zphotstat.fit.goodnessfloatnullableodds_morphOdds value for zmorphstat.fit.goodnessfloatnullableodds_bestOdds value for zbest (=1 if zspec is used)stat.fit.goodnessfloatnullablesource_specSource of spectroscopy: SDSS, BOSS, DEEP2, WIGGLEZ or VVDSmeta.bibcharnullableclass_specClass of object based on spectral fit: GALAXY or QSOmeta.code.classcharnullable
cstlConstellations as Polygons This table contains constellation data from Davenhall et al, +ivo://cds.vizier/vi/49, converted to ADQL-queriable polygons. The +polygons use the J2000 points, and we skip the interpolated points.cstl.geo This table contains constellation data from Davenhall et al, +ivo://cds.vizier/vi/49, converted to ADQL-queriable polygons. The +polygons use the J2000 points, and we skip the interpolated points.87abbrevAbbreviation of the constellation namemeta.id;meta.maincharnullablenameFull name of the constellation namemeta.idcharnullablepThe coverage of the constallationposdoubleindexednullableraRepresentative RA (actually, the mean of the vertices)degpos.eq.ra;meta.mainfloatnullabledecRepresentative Dec (actually, the mean of the vertices)degpos.eq.dec;meta.mainfloatnullable
danishMiNDSTEP Danish Observatory Lens ImagesTBDdanish.dataTBD2469accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableobservatObservatory the exposure was prepared atcharnullableinstrumemeta.id;instrcharnullabledetnamecharnullableorignameName given at La Sillameta.id;meta.filecharnullableobjectObject observedmeta.id;meta.maincharexptimeExposure timestime.duration;obs.exposurefloatnullabletm_startUT start timetime.epoch;obs.exposurecharnullabletm_endUT end timetime.epoch;obs.exposurecharnullablefilter_aFilter used on wheel Ameta.id;instr.filtercharnullablefilter_bFilter used on wheel Bmeta.id;instr.filtercharnullablefilterFilter usedmeta.id;instr.filter;meta.maincharnullablestSidereal time at startsfloatnullableraRight ascension at startdegpos.eq.ra;meta.mainfloatnullabledecDeclination at startdegpos.eq.dec;meta.mainfloatnullablehaHour Angle at startfloatnullablezdistZenith distance at startdegpos.az.zdfloatnullable
dfbsplatesDigitized First Byurakan Survey (DFBS) Plate Scans +The First Byurakan Survey (FBS) is the largest and the first systematic +objective prism survey of the extragalactic sky. It covers 17,000 sq.deg. +in the Northern sky together with a high galactic latitudes region in the +Southern sky. This service serves the scanned objective prism images +and offers SODA-based cutouts.dfbsplates.main +The First Byurakan Survey (FBS) is the largest and the first systematic +objective prism survey of the extragalactic sky. It covers 17,000 sq.deg. +in the Northern sky together with a high galactic latitudes region in the +Southern sky. This service serves the scanned objective prism images +and offers SODA-based cutouts.1711accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableplateIdentifier (plate number) for the DFBS plate.meta.idcharnullableexptimeExposure time.sfloatnullablepublisher_didDataset identifier assigned by the publisher.meta.ref.urlcharnullable
dfbsspecDigitized First Byurakan Survey (DFBS) Extracted Spectra +The First Byurakan Survey (FBS) is the largest and the first systematic +objective prism survey of the extragalactic sky. It covers 17,000 sq.deg. +in the Northern sky together with a high galactic latitudes region in the +Southern sky. The FBS has been carried out by B.E. Markarian, V.A. +Lipovetski and J.A. Stepanian in 1965-1980 with the Byurakan Observatory +102/132/213 cm (40"/52"/84") Schmidt telescope using 1.5 deg. prism. Each +FBS plate contains low-dispersion spectra of some 15,000-20,000 objects; +the whole survey consists of about 20,000,000 objects.dfbsspec.raw_spectra Raw metadata for the spectra, to be combined with image metadata like +date_obs and friends for a complete spectrum descriptions. This also +contains spectral and flux points in array-valued columns.24000000accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexedprimaryplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableobjectidSynthetic object id assigned by DFBS.meta.idcharnullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullableskySky background estimation from the scan (uncalibrated).instr.skyLevelfloatnullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullablepx_lengthNumber of points in this spectrumfloatnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharindexednullable
dfbsspec.ssaA view providing standard SSA metadata for DBFS metadata in +dfbsspec.spectra23213283accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullable
dfbsspec.spectraThis table contains basic metadata as well as the spectra from the +Digital First Byurakan Survey (DFBS).accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablepx_lengthNumber of points in this spectrumfloatnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullableepochDate of observation from WFPDB (this probably does not include the time).dtime.epochdoubleindexednullableexptimeExposure time from WFPDB.stime.duration;obs.exposurefloatnullableemulsionEmulsion used in this plate from WFPDB.instr.plate.emulsioncharnullablespectralSpectral points of the extracted spectrum (wavelengths) as an array (the points are the same for all spectra; the array in this column is cropped at the blue end to match the length of flux).mem.wlfloatnullablecutout_linkCutout of the image this spectrum was extracted frommeta.ref.urlcharnullable
dmubinDelta-mu BinariesA collection of binary stars with a difference in instantaneous proper +motion as measured by HIPPARCOS and the long-term proper motion.dmubin.mainA collection of binary stars with a difference in instantaneous proper +motion as measured by HIPPARCOS and the long-term proper motion.8039hipnoCatalog number in Hipparcos catalogmeta.id;meta.mainintraj2000Right ascension from Hipparcosdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination from Hipparcosdegpos.eq.dec;meta.maindoubleindexednullablecompComponent for resolved binariesmeta.codecharnullablemvVisual magnitudemagphot.mag;em.opt.VfloatnullablecolorColor index B-V, Hipparcos V magnitudemagphot.color;em.opt.B;em.opt.VfloatnullableparallaxParallax from Hipparcosmaspos.parallax.trigfloatnullableffhF-Measure for proper motions FK5 vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullablef0fF-measure for proper motions from FK5 vs. mu0Fstat.fit.goodness;pos.pm;arith.difffloatnullablef0hF-measure for proper motions from Hipparcos vs. mu0Fstat.fit.goodness;pos.pm;arith.difffloatnullablef0gchF-measure for proper motions from Hipparcos vs. mu0Gstat.fit.goodness;pos.pm;arith.difffloatnullableft2hF-measure for proper motions from Hipparcos vs. Tycho-2stat.fit.goodness;pos.pm;arith.difffloatnullablefmaxMaximum of F-measures reportedstat.fit.goodness;pos.pm;arith.difffloatnullablefkFK Part the star was found inmeta.refcharnullablegcStar Identifier in the GCmeta.id.crossintnullablet2Object is in Tycho-2meta.codebooleanhdStar Identifier in the HD-Cataloguemeta.id.crossintnullablehrStar Identifier in the HR-Cataloguemeta.id.crossintnullablecns4Star Identifier in CNS4meta.id.crosscharnullablefknoStar Identifier in the FKmeta.id.crossintnullablestar_nameName of the starmeta.idcharnullableccdmStar Identifier in the CCDM-Cataloguemeta.id.crosscharnullable
emiVLBI images of Lockman Hole radio sources These are 1.4GHz Very Long Baseline Interferometry images of 532 +radio sources with a flux density exceeding 100uJy as determined by +Ibar et al. (2009, MNRAS, 397, 281), obtained between 2010-06-03 and +2010-09-03. + +For all fields, we give frames processed using natural weighting to +preserve maximal sensitivity. For the 65 detected sources, we +additionally give frames processed using uniform weighting to suppress +sidelobes (see Middelberg et al. 2013, A&A 551, 97 for details) in +flux density measurements. Some sources have larger images to cover a +larger area because the initial coordinates were not sufficiently +accurate.emi.main These are 1.4GHz Very Long Baseline Interferometry images of 532 +radio sources with a flux density exceeding 100uJy as determined by +Ibar et al. (2009, MNRAS, 397, 281), obtained between 2010-06-03 and +2010-09-03. + +For all fields, we give frames processed using natural weighting to +preserve maximal sensitivity. For the 65 detected sources, we +additionally give frames processed using uniform weighting to suppress +sidelobes (see Middelberg et al. 2013, A&A 551, 97 for details) in +flux density measurements. Some sources have larger images to cover a +larger area because the initial coordinates were not sufficiently +accurate.561dataproduct_typeHigh level scientific classification of the data product, taken from an enumerationmeta.code.classobscore:obsdataset.dataproducttypecharnullabledataproduct_subtypeData product specific typemeta.code.classobscore:obsdataset.dataproductsubtypecharnullablecalib_levelAmount of data processing that has been applied to the datameta.code;obs.calibobscore:obsdataset.caliblevelshortobs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameSource name as in 2009MNRAS.397..281I (VizieR J/MNRAS/397/281)meta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_resolutionMinimal significant time interval along the time axisstime.resolutionobscore:char.timeaxis.resolution.refval.valuefloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablepol_statesList of polarization states in the data setmeta.code;phys.polarizationobscore:Char.PolarizationAxis.stateListcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullablet_xelNumber of elements (typically pixels) along the time axis.meta.numberobscore:Char.TimeAxis.numBinslongnullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullablepol_xelNumber of elements (typically pixels) along the polarization axis.meta.numberobscore:Char.PolarizationAxis.numBinslongnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullableem_ucdNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)meta.ucdobscore:Char.SpectralAxis.ucdcharnullablesource_tableName of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.meta.id;meta.tablecharnullableobsraAntenna pointing, RAdegpos.eq.rafloatnullableobsdecAntenna pointing, Decdegpos.eq.decfloatnullableweightingNatural or uniform, according to weighting method.meta.codecharnullables_resolution_minAngular resolution, longest baseline and max frequency dependentarcsecpos.angResolution;stat.minChar.SpatialAxis.Resolution.Bounds.Limits.LoLimfloatnullables_resolution_maxAngular resolution, longest baseline and min frequency dependentarcsecpos.angResolution;stat.maxChar.SpatialAxis.Resolution.Bounds.Limits.HiLimfloatnullable
ferosFEROS Public Spectra Spectra from FEROS spectrograph at La Silla's 1.5m telescope as +obtained during commissioning and guaranteed time.feros.data Spectra from FEROS spectrograph at La Silla's 1.5m telescope as +obtained during commissioning and guaranteed time.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullable
fk6The Sixth Fundamental Catalogue (FK6) Parts I and III of the sixth fundamental catalog, a catalog of +high-precision astrometry for bright stars combining centuries of +ground-based observations as reflected in FK5 with HIPPARCOS +astrometry. + +The result contains, in particular for the proper motions, +statistically significant improvements of the Hipparcos data und +represents a system of unprecedented accuracy for these 4150 +fundamental stars. The typical mean error in pm is 0.35 mas/year for +878 basic stars, and 0.59 mas/year for the sample of the 3272 +additional stars.fk6.part1Part I of the FK6 (successor to Basic FK5)878hipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubleindexeddej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoubleindexedpmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortlocalidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharindexedprimaryraltpRight ascension in LTP modedegpos.eq.radoublenullabledeltpDeclination in LTP modedegpos.eq.decdoublenullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullableepraltpCentral epoch of RA (LTP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_raltpError in RA (LTP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdeltpCentral epoch of Dec (LTP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_deltpError in Dec (LTP)degstat.error;pos.eq.decfloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerastpRight ascension in STP modedegpos.eq.radoublenullabledestpDeclination in STP modedegpos.eq.decdoublenullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullableeprastpCentral epoch of RA (STP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rastpError in RA (STP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdestpCentral epoch of Dec (STP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_destpError in Dec (STP)degstat.error;pos.eq.decfloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerahipRight ascension in HIP modedegpos.eq.radoublenullabledehipDeclination in HIP modedegpos.eq.decdoublenullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullableeprahipCentral epoch of RA (HIP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rahipError in RA (HIP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdehipCentral epoch of Dec (HIP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_dehipError in Dec (HIP)degstat.error;pos.eq.decfloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxsiParallax obtained in solution SIdegpos.parallaxfloatnullablee_parallaxsiError in parallax obtained in solution SIdegstat.error;pos.parallaxfloatnullableparallaxstpParallax obtained in solution STPdegpos.parallaxfloatnullablee_parallaxstpError in parallax obtained in solution STPdegstat.error;pos.parallaxfloatnullableparallaxhipParallax obtained in solution HIPdegpos.parallaxfloatnullablee_parallaxhipError in parallax obtained in solution HIPdegstat.error;pos.parallaxfloatnullablenoteNote for this objectmeta.notecharnullable
fk6.part3Part III of the FK6 (containing stars from the FK5 extension and Rsup)3273localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharsubsampleFlag for the subsample of FK6(III) stars; BX and FX denote stars from the bright and faint FK5 extensions, respectively, RS denotes stars from RSup (1993VeARI..34....1S)meta.id;meta.datasetcharnullablehipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortpmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablehipdupHIPPARCOS indicators for a suspected visual binary; d=duplicity induced variability (H52), s=Hipparcos suspected non-single (H61), t=bothmeta.code.multipcharnullablehipfitqualHIPPARCOS goodness-of-fit parameter (HIP Field H30, F2); A large value of F2 (e.g. larger than 3) may be caused by a duplicity of the object, but other reasons cannot be excluded. NULL means a negative goodness-of-fit in HIP.meta.code.qualshortnullablespeckleflagIndications on binarity provided by the catalogue of speckle observations (1999AJ....117.1890M); b=binarity resolved, u=possibly resolved, n=object observed but not resolvedmeta.code.multipcharnullableviscompIndicator for a star which has one (or more) visual component(s) with a separation rho of at least 60 arcsec.meta.code.multipcharnullablebinindsrvIndications for binarity provided by radial velocities from various sources (see Note)meta.code.multipcharnullablebinindeclIndicators for binarity from photometric variability (a=Algol-type, b=β Lyr-type, e=uncertain type, w=W UMa type)meta.code;src.varcharnullablepulsatingIndicator for a variability of the radial velocity V_rad due to stellar pulsation (which may be confused with a variability of V_rad due to spectroscopic binarity; c=Cepheid, s=δ Sct, b=β Cep)meta.code;src.varcharnullablenoteNote for this objectmeta.notecharnullable
fk6.fk6joinThe union of all published parts of FK6, comprising only the common +fields.4151localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharhipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortnoteNote for this objectmeta.notecharnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
flare_surveyPlates From Münster Flare Star Survey 1986-1991 From 1986 through 1991, the Astronomical Institute of Münster +University performed a search for flare stars in several southern +associations and open stellar clusters using the GPO telescope (d=40 +cm, WFPDB identifier ESO040); the fields suveyed include Coalsack, +M42, B228 Lup, the Chameleon T1 association, omicron Vel cluster, R +CrA association, the Pipe nebula (B59 Oph), and the Sco-Oph +association. This was done primarily through multiple exposures. The +files published here are plate scans done in 2017. + +The obscore collection name for these files is Muenster Flare Survey.flare_survey.data From 1986 through 1991, the Astronomical Institute of Münster +University performed a search for flare stars in several southern +associations and open stellar clusters using the GPO telescope (d=40 +cm, WFPDB identifier ESO040); the fields suveyed include Coalsack, +M42, B228 Lup, the Chameleon T1 association, omicron Vel cluster, R +CrA association, the Pipe nebula (B59 Oph), and the Sco-Oph +association. This was done primarily through multiple exposures. The +files published here are plate scans done in 2017. + +The obscore collection name for these files is Muenster Flare Survey.580accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablekindDirect observation, stellar tracks, or multiple exposure?meta.code;obscharnullableobjectName of the target object (mostly, cluster or association)meta.id;srccharindexednullableobs_durationTime between first shutter open and last shutter close (for multiply exposed plates, this is not the total exposure time)stime.interval;obs.exposurefloatnullabletotal_exptimeLength of exposure (non-contiguous for multiply exposed platesstime.duration;obs.exposurefloatnullableemulsionPhotographic emulsion used.instr.plate.emulsioncharnullablepub_didPublisher data set id; this is an identifier for the dataset in question and can be used to retrieve the data through, e.g., datalink.meta.id;meta.maincharnullabledatalink_urlURL to a datalink document for this plate (ancillary files, cutouts)meta.ref.urlcharnullablewfpdb_idPlate identifier as in the WFPDBmeta.idcharnullable
flashherosFlash/Heros Heidelberg spectra Spectra from the Flash and Heros Echelle spectrographs developed at +Landessternwarte Heidelberg and mounted at La Silla and various other +observatories. The data mostly contains spectra of OB stars. Heros was +the name of the instrument after Flash got a second channel in 1995.flashheros.dataFlash/Heros SSA table Spectra from the Flash and Heros Echelle spectrographs developed at +Landessternwarte Heidelberg and mounted at La Silla and various other +observatories. The data mostly contains spectra of OB stars. Heros was +the name of the instrument after Flash got a second channel in 1995.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablelocalkeyLocal observation key (used to connect to single orders).meta.idcharnullablessa_fluxcalibType of flux calibrationssa:Char.FluxAxis.Calibrationcharnullable
flashheros.ordersmetaSSA metadata for split-order Flash/Heros Echelle spectraaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.LengthintnullablelocalkeyLocal observation key.meta.idcharnullablen_ordersNumber of orders in the spectrum.meta.numberintnullableorder_minMinimal Echelle order in the spectrum.instr.order;stat.minintnullableorder_maxMaximal Echelle order in the spectrum.instr.order;stat.maxintnullable
fornaxDeep Mosaic of the Fornax cluster core This is a deep optical mosaic of the Fornax cluster’s core, covering +1.6 square degrees. The data were acquired with ESO/MPG 2.2m/WFI, +using a transparent filter that nearly equals the no-filter throughput +and thus provides a high signal-to-noise ratio. Based on an +approximate conversion to V-band magnitudes, the unbinned and binned +mosaics (0.24 and 0.71 arcsec/pixel) reach a median depth of 26.6 and +27.8 mag/sq.arcsec, respectively.fornax.data This is a deep optical mosaic of the Fornax cluster’s core, covering +1.6 square degrees. The data were acquired with ESO/MPG 2.2m/WFI, +using a transparent filter that nearly equals the no-filter throughput +and thus provides a high signal-to-noise ratio. Based on an +approximate conversion to V-band magnitudes, the unbinned and binned +mosaics (0.24 and 0.71 arcsec/pixel) reach a median depth of 26.6 and +27.8 mag/sq.arcsec, respectively.2accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullabledidGlobally unique IVOA publisher DID for this dataset.meta.idcharnullabledatalink_urlURL to a datalink document for this mosaic (ancillary files, cutouts)meta.ref.urlcharnullable
gaiaSelections from Gaia Data Release 2 (DR2) +This schema contains data re-published from the official +Gaia mirrors (such as ivo://uni-heidelberg.de/gaia/tap) either to +support combining its data with local tables (the various Xlite tables) +or to make the data more accessible to VO clients (e.g., epoch fluxes). + +Other Gaia-related data is found in, among others, the gdr2dist, gdr3mock, +gdr3spec, gedr3auto, gedr3dist, gedr3mock, and gedr3spur schemas.gaia.dr3liteGaia DR3 source catalogue "light" This is gaia_source from the Gaia Data Release 3, stripped to just +enough columns to enable basic science (but therefore a bit faster and +simpler to deal with than the full gaia_source table). + +Note that on this server, there is also The gedr3dist.main, which +gives distances computed by Bailer-Jones et al. Use these in +preference to working with the raw parallaxes. + +This server also carries the gedr3mock schema containing a simulation +of gaia_source based on a state-of-the-art galaxy model, computed by +Rybizki et al. + +The full DR3 is available from numerous places in the VO (in +particular from the TAP services ivo://uni-heidelberg.de/gaia/tap and +ivo://esavo/gaia/tap).1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.edr3liteGaia eDR3 source catalogue "light" This is a “light” version of the full Gaia DR3 gaia_source table. It +is just a view copying gaia.dr3lite, which should preferentially be +used in new queries. This table is being kept around in order to keep +legacy queries from breaking unnecessarily. However, it is actually +DR3 data rather than eDR3. The minute differences did not seem to +warrant keeping two copies of the relatively massive data around.1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.dr2lightGaia DR2 source catalogue "light" +This is a “light” version of the full Gaia DR2 gaia_source table, +containing the original astrometric and photmetric columns with just +enough additional information to let careful researchers notice when data +is becomes uncertain and the full error model should be consulted. The +full DR2 is available from numerous places in the VO (in particular from +the TAP services ivo://uni-heidelberg.de/gaia/tap and +ivo://esavo/gaia/tap). + +This table also includes a column containing the Renormalized Unit Weight +Error RUWE (GAIA-C3-TN-LU-LL-124-01), a robust measure for the +consistency of the solution. + +On this TAP service, there is the table gdr2dist.main containing +distances computed by Bailer-Jones et al (:bibcode:`2018AJ....156...58B`). +If in doubt, use these instead of the parallaxes provided here.1600000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codefloatnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.dr2epochfluxGaia DR2 epoch fluxes +A table of the light curves released with Gaia DR2 (about half a million +in total). In each Gaia band (G, BP, RP), we give epochs, fluxes and +their errors in arrays. We do not include the quality flags (DR2: “may +be safely ignored for many general purpose applications”). You can +access them through the associated datalink service if you select +source_id. You will usually join this table with gaia.dr2light. + +We have also removed all entries with NaN observation times; hence, +the array lengths in the different bands can be significantly different, +and the indices in transit_ids do not always correspond to the +indices in the time series. + +Furthermore, we only give fluxes and their errors here rather than +magnitudes. Fluxes can be turned into magnitude using:: + + mag = -2.5 log10(flux)+zero point, + +where the zero points assumed for Gaia DR2 are +25.6884±0.0018 in G, 25.3514±0.0014 in BP, and +24.7619±0.0019 in RP (VEGAMAG).550737source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimarytransit_idTransit unique identifier. For a given object, a transit comprises the different Gaia observations (SM, AF, BP, RP and RVS) obtained for each focal plane crossing. NOTE: Where invalid observations have been removed, transit_id *cannot* be joined with times and fluxes.meta.versionlongnullableg_transit_timeThe field-of-view transit averaged observation times for the G-band observations. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullableg_transit_fluxG-band fluxes for the transit, for combination with g_transit_time_mjd. Here, this is a combination of individual SM-AF CCD fluxess**-1phot.flux;em.opt.Vfloatnullableg_transit_flux_errorThe error in G-band flux.s**-1stat.error;phot.flux;em.opt.Vfloatnullablerp_obs_timeThe observation time of the RP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablerp_fluxRP-band integrated fluxes, for combination with rp_obs_times**-1phot.flux;em.opt.Rfloatnullablerp_flux_errorThe error in RP-band flux.s**-1stat.error;phot.flux;em.opt.Rfloatnullablebp_obs_timeThe observation time of the BP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablebp_fluxBP-band integrated fluxes, for combination with bp_obs_times**-1phot.flux;em.opt.Bfloatnullablebp_flux_errorThe error in BP-band flux.s**-1stat.error;phot.flux;em.opt.Bfloatnullablesolution_idA DPAC id for the toolchain used to produce these particular time series. It is given to facilitate comparison with ESAC data products.meta.versionlonggaia.dr2lightsource_idsource_id
gaia.dr2_ts_ssaGaia DR2 Timeseries SSA Table This table contains about 1.5 Million photometric timeseries for +roughly 0.5 Million objects. Photometry is available in the Gaia G, +BP, and RP bands for epochs between 2014-07-25 and 2016-05-25. The +spectra are available in VOTable format with the timeseries annotation +proposed in the Nadvornik et al IVOA note.1700000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullabletime_minFirst timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.mindoubleindexednullabletime_maxLast timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.maxdoubleindexednullable
gcnsThe Gaia eDR3 Catalogue of Nearby Stars GCNS +This is a clean and well characterised catalogue of objects within 100pc of +the Sun from the Gaia early third data release. We characterise the +catalogue using the full data release, and comparisons to other catalogues +in literature and simulations. For all candidates (measured parallax < +8 mas), we calculate a distance probability function using Bayesian +procedures and mock catalogues for the prediction of the priors. For each +entry using a random forest classifier we attempt to remove sources with +spurious astrometric solutions. + +This results in 331312 objects that should contain at least 92% of stars +within 100 pc at spectral type M9. + +GCNS comes with several auxiliary tables, in particular lists of +resolved stellar systems, of known neary stars not found in eDR3 and +of candidates of Hyades and ComaBer cluster members.gcns.maineDR3 Gaia Catalogue of Nearby Stars (GCNS)This is the main catalogue. Additional resources include: +gcns.resolvedss (resolved stellar systems), gcns.missing_10mas +(objects missing from eDR3 that have been suspected of being within +100 pc before), and gcns.hyacob (probable members of the Hyades and +the Coma Berenices open cluster).331312source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.rejectedeDR3 GCNS: Rejected ObjectsThis is the catalogue of objects in the 8mas sample that were rejected +for the main Gaia Catalogue of Nearby Stars as having a zero +probability of being inside 100pc or indicated as a spurious +astrometric solution.source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.resolvedsseDR3 GCNS Resolved Binary Candidates +Resolved binary candidates in the GCNS catalogue as discussed in +https://doi.org/10.1051/0004-6361/202039498, “stellar multiplicity: +resolved systems”. You probably want to join this table to gaia.edr3lite +using source_id1 and/or source_id2.19176source_id1Gaia EDR3 source_id of the primary starmeta.id.partlongsource_id2Gaia EDR3 source_id of secondary startmeta.id.partlongseparationAngular separation of the two sources.arcsecpos.angDistancefloatnullablemag_diffG magnitude difference between the two componentsmagphot.mag;arith.diff;em.opt.Vfloatnullableproj_sepProjected separation of the pairAUphys.sizefloatnullablebin1 if the system is probably made up of more than two stars, 0 otherwise.meta.code.multipshortbound1 if the system is probably gravitationally bound, 0 otherwisemeta.codeshort
gcns.missing_10maseDR3 GCNS list of possibly nearby stars missingA table of 1258 objects with published parallaxes greater than 10mas +that are not or have no parallax in Gaia eDR3 and are hence not listed +in gcns.main.1259main_idSource name from Simbadmeta.id;meta.maincharnullableraICRS RA from Simbaddegpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec from Simbaddegpos.eq.dec;meta.maindoubleindexednullableplx_valueParallax from Simbadmaspos.parallaxfloatnullableplx_bibcodeSource reference for the parallaxmeta.bib.bibcodecharnullableotypeSimbad object typemeta.code.classcharnullable
gcns.hyacobeDR3 GCNS open cluster membership table A list of 920+212 probable Hyades and ComaBer members in the eDR3 +GCNS sample.1132source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullablenameName of the cluster this object probably belongs tometa.idcharnullablec_clusterDimensionless chi-square test statistic. Small values indicate highly probable members (cf. eq. 4 in 2018MNRAS.477.3197R)stat.likelihoodfloatnullabledist_clusterDistance of each star from the cluster barycentre.pcpos.distancefloatnullablegcns.mainsource_idsource_id
gcns.maglims5Magnitude distribution over 5-HEALPixes The G magnitude distribution percentiles per level 5 HEALpixes for +all Gaia sources with a parallax and a G magnitude measurement. Can be +used to approximate the G magnitude limit for Gaia at that position of +the sky. Sources up to a limiting magnitude equal to 'magnitude_70' +are 98% complete when compared to PS1. The 80th and 90th percentile +decrease the completeness in Gaia to 97% and 95%, respectively. These +cuts can be very useful, when trying to compare Gaia data to models, +e.g. the GeDR3mock catalog (gedrmock.main).12288hpxHEALPix on level 5 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcns.maglims6Magnitude distribution over 6-HEALPixes The G magnitude distribution percentiles per level 6 HEALpixes for +all Gaia sources with a parallax and a G magnitude measurement. Can be +used to approximate the G magnitude limit for Gaia at that position of +the sky. Sources up to a limiting magnitude equal to 'magnitude_70' +are 98% complete when compared to PS1. The 80th and 90th percentile +decrease the completeness in Gaia to 97% and 95%, respectively. These +cuts can be very useful, when trying to compare Gaia data to models, +e.g. the GeDR3mock catalog (gedrmock.main).49152hpxHEALPix on level 6 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcns.maglims7Magnitude distribution over 7-HEALPixes The G magnitude distribution percentiles per level 7 HEALpixes for +all Gaia sources with a parallax and a G magnitude measurement. Can be +used to approximate the G magnitude limit for Gaia at that position of +the sky. Sources up to a limiting magnitude equal to 'magnitude_70' +are 98% complete when compared to PS1. The 80th and 90th percentile +decrease the completeness in Gaia to 97% and 95%, respectively. These +cuts can be very useful, when trying to compare Gaia data to models, +e.g. the GeDR3mock catalog (gedrmock.main).196608hpxHEALPix on level 7 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcpmsStellar Proper Motions in the Ogle II Galactic Bulge FieldsA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic +bulge (GB) fields, covering a range of -11°<l<11° and -6°<b<3°. Some +columns have been left out from the original source.gcpms.dataA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic +bulge (GB) fields, covering a range of -11°<l<11° and -6°<b<3°. Some +columns have been left out from the original source.5100000fieldOGLE field numbermeta.id;obs.fieldshortogleOGLE numbermeta.id;meta.mainintnpointNumber of data pointsmeta.number;stat.fitshortpmraProper motion in right ascension (mu(RA)cos(DE)deg/yrpos.pm;pos.eq.rafloatnullablee_pmrarms uncertainty on pmRAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in declination (mu(DE))deg/yrpos.pm;pos.eq.decfloatnullablee_pmderms uncertainty on pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullabledrefcDifferential refraction coefficientdegfloatnullablesdevStandard deviation of data points in the fittingdegstat.stdev;posfloatnullableimagI magnitudemagphot.mag;em.opt.Ifloatnullablev_iV-I colour indexmagphot.color;em.opt.V;em.opt.Ifloatnullableraj2000Right ascension in decimal degrees (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination in decimal degrees (J2000)degpos.eq.dec;meta.maindoubleindexednullablexposx pixel coordinate in template imagepixpos.cartesian.x;instr.detfloatnullableyposy pixel coordinate in template imagepixpos.cartesian.y;instr.detfloatnullable
gdr2apAstrophysical parameters from Gaia DR2, 2MASS and AllWise We estimated the stellar astrophysical parameters of 120 million +stars over the entire sky that have Gaia parallax and photometry from +Gaia DR2, 2MASS, and AllWISE. We provide estimates of log age, log +mass, log temperature, log luminosity, log surface gravity, distance +modulus, dust extinction (A0), and average grain size (R0) along the +lines of sight. In contrast with other catalogs, we do not use a +Galactic model as prior but weakly informative ones. Our estimate and +uncertainties are quantiles, so they are invariant under monotonic +transformations (e.g., log, exp). This means that one can use our +median estimate to obtain the median distance or temperature, for +instance, and likewise for the uncertainties.gdr2ap.main We estimated the stellar astrophysical parameters of 120 million +stars over the entire sky that have Gaia parallax and photometry from +Gaia DR2, 2MASS, and AllWISE. We provide estimates of log age, log +mass, log temperature, log luminosity, log surface gravity, distance +modulus, dust extinction (A0), and average grain size (R0) along the +lines of sight. In contrast with other catalogs, we do not use a +Galactic model as prior but weakly informative ones. Our estimate and +uncertainties are quantiles, so they are invariant under monotonic +transformations (e.g., log, exp). This means that one can use our +median estimate to obtain the median distance or temperature, for +instance, and likewise for the uncertainties.130000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimarya0_bestmultivariate maximum posterior estimate for the dust exctinction A₀ towards this source.magphys.absorptionfloatnullablea0_p50median of the distribution of dust exctinction A₀ towards this source.magphys.absorption;stat.medianfloatindexednullablea0_distDistribution (min, p16, p25, p50, p75, p84, max) of the dust exctinction A₀ towards this source. In ADQL, write a0_dist[1] for the minimum, a0_dist[2] for the 16th percentile, and so on.magstat;phys.absorptionfloatnullabler0_bestmultivariate maximum posterior estimate for the average dust grain size extinction parameter.phys.absorptionfloatnullabler0_p50median of the distribution of average dust grain size extinction parameter.phys.absorption;stat.medianfloatindexednullabler0_distDistribution (min, p16, p25, p50, p75, p84, max) of the average dust grain size extinction parameter. In ADQL, write r0_dist[1] for the minimum, r0_dist[2] for the 16th percentile, and so on.stat;phys.absorptionfloatnullableloga_bestmultivariate maximum posterior estimate for the log10 of the age.log(yr)time.agefloatnullableloga_p50median of the distribution of log10 of the age.log(yr)time.age;stat.medianfloatnullableloga_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the age. In ADQL, write loga_dist[1] for the minimum, loga_dist[2] for the 16th percentile, and so on.log(yr)stat;time.agefloatnullablelogl_bestmultivariate maximum posterior estimate for the log10 of the luminosity.log(solLum)phys.luminosityfloatnullablelogl_p50median of the distribution of log10 of the luminosity.log(solLum)phys.luminosity;stat.medianfloatindexednullablelogl_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the luminosity. In ADQL, write logl_dist[1] for the minimum, logl_dist[2] for the 16th percentile, and so on.log(solLum)stat;phys.luminosityfloatnullablelogm_bestmultivariate maximum posterior estimate for the log10 of the mass.log(solMass)phys.massfloatnullablelogm_p50median of the distribution of log10 of the mass.log(solMass)phys.mass;stat.medianfloatnullablelogm_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the mass. In ADQL, write logm_dist[1] for the minimum, logm_dist[2] for the 16th percentile, and so on.log(solMass)stat;phys.massfloatnullablelogt_bestmultivariate maximum posterior estimate for the log10 of the effective temperature.log(K)phys.temperaturefloatnullablelogt_p50median of the distribution of log10 of the effective temperature.log(K)phys.temperature;stat.medianfloatindexednullablelogt_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the effective temperature. In ADQL, write logt_dist[1] for the minimum, logt_dist[2] for the 16th percentile, and so on.log(K)stat;phys.temperaturefloatnullablelogg_bestmultivariate maximum posterior estimate for the log10 of the surface gravity.log(cm/s**2)phys.gravityfloatnullablelogg_p50median of the distribution of log10 of the surface gravity.log(cm/s**2)phys.gravity;stat.medianfloatnullablelogg_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the surface gravity. In ADQL, write logg_dist[1] for the minimum, logg_dist[2] for the 16th percentile, and so on.log(cm/s**2)stat;phys.gravityfloatnullablea_bp_bestmultivariate maximum posterior estimate for the attenuation in the Gaia BP band towards this source..magphys.absorption;em.opt.Bfloatnullablea_bp_p50median of the distribution of attenuation in the Gaia BP band towards this source..magphys.absorption;em.opt.B;stat.medianfloatnullablea_bp_distDistribution (min, p16, p25, p50, p75, p84, max) of the attenuation in the Gaia BP band towards this source.. In ADQL, write a_bp_dist[1] for the minimum, a_bp_dist[2] for the 16th percentile, and so on.magstat;phys.absorption;em.opt.Bfloatnullablea_g_bestmultivariate maximum posterior estimate for the attenuation in the Gaia G band towards this source..magphys.absorption;em.optfloatnullablea_g_p50median of the distribution of attenuation in the Gaia G band towards this source..magphys.absorption;em.opt;stat.medianfloatnullablea_g_distDistribution (min, p16, p25, p50, p75, p84, max) of the attenuation in the Gaia G band towards this source.. In ADQL, write a_g_dist[1] for the minimum, a_g_dist[2] for the 16th percentile, and so on.magstat;phys.absorption;em.optfloatnullablea_rp_bestmultivariate maximum posterior estimate for the attenuation in the Gaia RP band towards this source..magphys.absorptionfloatnullablea_rp_p50median of the distribution of attenuation in the Gaia RP band towards this source..magphys.absorption;stat.medianfloatnullablea_rp_distDistribution (min, p16, p25, p50, p75, p84, max) of the attenuation in the Gaia RP band towards this source.. In ADQL, write a_rp_dist[1] for the minimum, a_rp_dist[2] for the 16th percentile, and so on.magstat;phys.absorptionfloatnullablemag_bpRecalibrated Gaia BP magnitude.magphot.mag;em.opt.Bfloatnullableerr_bpRecalibrated error from original Gaia BP magnitude.magstat.error;phot.mag;em.opt.Bfloatnullablebp_bestmultivariate maximum posterior estimate for the Gaia BP magnitude.magphot.mag;em.opt.Bfloatnullablebp_p50median of the distribution of Gaia BP magnitude.magphot.mag;em.opt.B;stat.medianfloatnullablebp_distDistribution (min, p16, p25, p50, p75, p84, max) of the Gaia BP magnitude. In ADQL, write bp_dist[1] for the minimum, bp_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.opt.Bfloatnullablemag_gRecalibrated Gaia G magnitude.magphot.mag;em.optfloatnullableerr_gRecalibrated error from original Gaia G magnitude.magstat.error;phot.mag;em.optfloatnullableg_bestmultivariate maximum posterior estimate for the Gaia G magnitude.magphot.mag;em.optfloatnullableg_p50median of the distribution of Gaia G magnitude.magphot.mag;em.opt;stat.medianfloatnullableg_distDistribution (min, p16, p25, p50, p75, p84, max) of the Gaia G magnitude. In ADQL, write g_dist[1] for the minimum, g_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.optfloatnullablemag_rpRecalibrated Gaia RP magnitude.magphot.mag;em.opt.Rfloatnullableerr_rpRecalibrated error from original Gaia RP magnitude.magstat.error;phot.mag;em.opt.Rfloatnullablerp_bestmultivariate maximum posterior estimate for the Gaia RP magnitude.magphot.mag;em.opt.Rfloatnullablerp_p50median of the distribution of Gaia RP magnitude.magphot.mag;em.opt.R;stat.medianfloatnullablerp_distDistribution (min, p16, p25, p50, p75, p84, max) of the Gaia RP magnitude. In ADQL, write rp_dist[1] for the minimum, rp_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.opt.Rfloatnullablemag_jRecalibrated 2MASS J magnitude.magphot.mag;em.IR.Jfloatnullableerr_jRecalibrated error from original 2MASS J magnitude.magstat.error;phot.mag;em.IR.Jfloatnullablej_bestmultivariate maximum posterior estimate for the 2MASS J magnitude.magphot.mag;em.IR.Jfloatnullablej_p50median of the distribution of 2MASS J magnitude.magphot.mag;em.IR.J;stat.medianfloatnullablej_distDistribution (min, p16, p25, p50, p75, p84, max) of the 2MASS J magnitude. In ADQL, write j_dist[1] for the minimum, j_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.Jfloatnullablemag_hRecalibrated 2MASS H magnitude.magphot.mag;em.IR.Hfloatnullableerr_hRecalibrated error from original 2MASS H magnitude.magstat.error;phot.mag;em.IR.Hfloatnullableh_bestmultivariate maximum posterior estimate for the 2MASS H magnitude.magphot.mag;em.IR.Hfloatnullableh_p50median of the distribution of 2MASS H magnitude.magphot.mag;em.IR.H;stat.medianfloatnullableh_distDistribution (min, p16, p25, p50, p75, p84, max) of the 2MASS H magnitude. In ADQL, write h_dist[1] for the minimum, h_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.Hfloatnullablemag_ksRecalibrated 2MASS Ks magnitude.magphot.mag;em.IR.Kfloatnullableerr_ksRecalibrated error from original 2MASS Ks magnitude.magstat.error;phot.mag;em.IR.Kfloatnullableks_bestmultivariate maximum posterior estimate for the 2MASS Ks magnitude.magphot.mag;em.IR.Kfloatnullableks_p50median of the distribution of 2MASS Ks magnitude.magphot.mag;em.IR.K;stat.medianfloatnullableks_distDistribution (min, p16, p25, p50, p75, p84, max) of the 2MASS Ks magnitude. In ADQL, write ks_dist[1] for the minimum, ks_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.Kfloatnullablemag_w1Recalibrated WISE W1 magnitude.magphot.mag;em.IR.3-4umfloatnullableerr_w1Recalibrated error from original WISE W1 magnitude.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1_bestmultivariate maximum posterior estimate for the WISE W1 magnitude.magphot.mag;em.IR.3-4umfloatnullablew1_p50median of the distribution of WISE W1 magnitude.magphot.mag;em.IR.3-4um;stat.medianfloatnullablew1_distDistribution (min, p16, p25, p50, p75, p84, max) of the WISE W1 magnitude. In ADQL, write w1_dist[1] for the minimum, w1_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.3-4umfloatnullablemag_w2Recalibrated WISE W2 magnitude.magphot.mag;em.IR.4-8umfloatnullableerr_w2Recalibrated error from original WISE W2 magnitude.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2_bestmultivariate maximum posterior estimate for the WISE W2 magnitude.magphot.mag;em.IR.4-8umfloatnullablew2_p50median of the distribution of WISE W2 magnitude.magphot.mag;em.IR.4-8um;stat.medianfloatnullablew2_distDistribution (min, p16, p25, p50, p75, p84, max) of the WISE W2 magnitude. In ADQL, write w2_dist[1] for the minimum, w2_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.4-8umfloatnullabledmod_bestmultivariate maximum posterior estimate for the distance modulus.magphot.mag.distModfloatnullabledmod_p50median of the distribution of distance modulus.magphot.mag.distMod;stat.medianfloatnullabledmod_distDistribution (min, p16, p25, p50, p75, p84, max) of the distance modulus. In ADQL, write dmod_dist[1] for the minimum, dmod_dist[2] for the 16th percentile, and so on.magstat;phot.mag.distModfloatnullablelnlike_bestmultivariate maximum posterior estimate for the log likelihood of the solution (paper Eq. 1).stat.paramfloatnullablelnlike_p50median of the distribution of log likelihood of the solution (paper Eq. 1).stat.param;stat.medianfloatnullablelnlike_distDistribution (min, p16, p25, p50, p75, p84, max) of the log likelihood of the solution (paper Eq. 1). In ADQL, write lnlike_dist[1] for the minimum, lnlike_dist[2] for the 16th percentile, and so on.stat;stat.paramfloatnullablelnp_bestmultivariate maximum posterior estimate for the log posterior of the solution (paper Eq. 2).stat.probabilityfloatnullablelnp_p50median of the distribution of log posterior of the solution (paper Eq. 2).stat.probability;stat.medianfloatnullablelnp_distDistribution (min, p16, p25, p50, p75, p84, max) of the log posterior of the solution (paper Eq. 2). In ADQL, write lnp_dist[1] for the minimum, lnp_dist[2] for the 16th percentile, and so on.stat;stat.probabilityfloatnullablelog10jitter_bestmultivariate maximum posterior estimate for the log photometric likelihood jitter common to all bands.log(mag)stat.paramfloatnullablelog10jitter_p50median of the distribution of log photometric likelihood jitter common to all bands.log(mag)stat.param;stat.medianfloatnullablelog10jitter_distDistribution (min, p16, p25, p50, p75, p84, max) of the log photometric likelihood jitter common to all bands. In ADQL, write log10jitter_dist[1] for the minimum, log10jitter_dist[2] for the 16th percentile, and so on.log(mag)stat;stat.paramfloatnullableparallaxRecalibrated parallax.maspos.parallaxfloatnullableerr_parallaxError in recalibrated parallax.masstat.error;pos.parallaxfloatnullable
gdr2distEstimated distances to 1.33 billion stars in Gaia DR2 +This catalogue provides distances estimates (and uncertainties therein) +for 1.33 billion stars over the whole sky brighter than about G=20.7. +These have been estimated using the parallaxes (and their uncertainties) +from Gaia DR2. A Bayesian procedure was used involving a prior +with a single parameter L(l,b), which varies smoothly with Galactic +longitude and latitude according to a Galaxy model. The posterior is +summarized with a point estimate (usually the mode) and a confidence +interval (usually the 68% highest density interval). The estimation +procedure is described in detail in the `accompanying paper`_, +which also analyses the catalogue content. + +.. _accompanying paper: http://www.mpia.de/homes/calj/gdr2_distances.htmlgdr2dist.main +This catalogue provides distances estimates (and uncertainties therein) +for 1.33 billion stars over the whole sky brighter than about G=20.7. +These have been estimated using the parallaxes (and their uncertainties) +from Gaia DR2. A Bayesian procedure was used involving a prior +with a single parameter L(l,b), which varies smoothly with Galactic +longitude and latitude according to a Galaxy model. The posterior is +summarized with a point estimate (usually the mode) and a confidence +interval (usually the 68% highest density interval). The estimation +procedure is described in detail in the `accompanying paper`_, +which also analyses the catalogue content. + +.. _accompanying paper: http://www.mpia.de/homes/calj/gdr2_distances.html1400000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimaryr_estEstimated distancepcpos.distancefloatindexednullabler_loLower bound on the 1 σ confidence intervalpcpos.distance;stat.minfloatnullabler_hiUpper bound on the 1 σ confidence intervalpcpos.distance;stat.maxfloatnullabler_lenLength scale used in the prior for the distance estimation.pcstat.fit.param;pos.distancefloatnullableresult_flagType of result.meta.code.qualshortmodality_flagResult regime flag: number of modes in the posterior (1 or 2).meta.codeshort
gdr2mockA Gaia DR2 mock stellar catalog This catalogue is a simulation of the Gaia DR2 stellar content using +Galaxia (a tool to sample stars from a Besancon-like Milky Way model), +3d dust extinction maps and the latest PARSEC Isochrones. It is +mimicking the Gaia DR2 data model and an apparent magnitude limit of +g=20,7. Extinctions and photometry in different bands have also been +included in a supplementary table as well as uncertainty estimates +using a scaled nominal error model.gdr2mock.photometryPhotometry for the Gaia DR2 mock catalogThis table contains simulated absolute magnitudes to about 0.1 mag +precision for all the stars, as well as extinctions in several bands; +To use it, join it USING (parsec_index) with the gdr2mock.main table.mag_gaia_gSimulated absolute magnitude in the Gaia G band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_uSimulated absolute magnitude in the Johnson U band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_ubv_bSimulated absolute magnitude in the Johnson B band (note that no extinction is applied).magphot.mag;em.opt.Bfloatnullablemag_ubv_vSimulated absolute magnitude in the Johnson V band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_rSimulated absolute magnitude in the Johnson R band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_ubv_iSimulated absolute magnitude in the Johnson I band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_ubv_jSimulated absolute magnitude in the Johnson J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_ubv_hSimulated absolute magnitude in the Johnson H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_ubv_kSimulated absolute magnitude in the Johnson K band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_sdss_uSimulated absolute magnitude in the SDSS u band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_sdss_gSimulated absolute magnitude in the SDSS g band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_sdss_rSimulated absolute magnitude in the SDSS r band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_sdss_iSimulated absolute magnitude in the SDSS i band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_sdss_zSimulated absolute magnitude in the SDSS z band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_2mass_jSimulated absolute magnitude in the 2MASS J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_2mass_hSimulated absolute magnitude in the 2MASS H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_2mass_ksSimulated absolute magnitude in the 2MASS K' band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_wise_w1Simulated absolute magnitude in the WISE W1 band (note that no extinction is applied).magphot.mag;em.ir.3-4umfloatnullablemag_wise_w2Simulated absolute magnitude in the WISE W2 band (note that no extinction is applied).magphot.mag;em.ir.4-8umfloatnullablemag_wise_w3Simulated absolute magnitude in the WISE W3 band (note that no extinction is applied).magphot.mag;em.ir.8-15umfloatnullablemag_wise_w4Simulated absolute magnitude in the WISE W4 band (note that no extinction is applied).magphot.mag;em.ir.15-30umfloatnullableindex_parsecThe parsec bin has the format AABBCCCDDD, where AA denotes the metallicity bin, BB the luminosity bin, CCC the T_eff bin, and DDD the extinction bin.meta.id;meta.maininta_bpExtinction in the Gaia BP bandmagphys.absorption;em.opt.Bfloatnullablea_rpExtinction in the Gaia RP bandmagphys.absorption;em.opt.Rfloatnullablea_juExtinction in the Johnson U bandmagphys.absorption;em.opt.Ufloatnullablea_jbExtinction in the Johnson B bandmagphys.absorption;em.opt.Bfloatnullablea_jvExtinction in the Johnson V bandmagphys.absorption;em.opt.Vfloatnullablea_jrExtinction in the Johnson R bandmagphys.absorption;em.opt.Rfloatnullablea_jiExtinction in the Johnson I bandmagphys.absorption;em.opt.Ifloatnullablea_jjExtinction in the Johnson J bandmagphys.absorption;em.ir.Jfloatnullablea_jhExtinction in the Johnson H bandmagphys.absorption;em.ir.Hfloatnullablea_jkExtinction in the Johnson K bandmagphys.absorption;em.ir.Kfloatnullablea_suExtinction in the SDSS u bandmagphys.absorption;em.opt.Ufloatnullablea_sgExtinction in the SDSS g bandmagphys.absorption;em.opt.Vfloatnullablea_srExtinction in the SDSS r bandmagphys.absorption;em.opt.Rfloatnullablea_siExtinction in the SDSS i bandmagphys.absorption;em.opt.Ifloatnullablea_szExtinction in the SDSS z bandmagphys.absorption;em.opt.Ifloatnullable
gdr2mock.mainA synthetic Milky Way catalog mimicking GDR2 in stellar content and +data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoubleindexednullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoubleindexednullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_magApproximate estimate for the RVS magnitude. This uses formulae (2) and (3) from 2018A&A...616A...1G. Outside of the range 0.1<BP-G<1.7 we use Eq. 3 (which means the value is probably fairly bogus).magphot.color;em.opt.Ifloatnullablerv_nb_transitsNumber of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epochReference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_qHipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noiseExcess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sigSignificance of excess noisestat.valuefloatnullableastrometric_n_obs_acTotal number of observations ACmeta.numbershortastrometric_n_obs_alTotal number of observations ALmeta.numbershortastrometric_n_bad_obs_acNumber of bad observations ACmeta.numbershortastrometric_n_bad_obs_alNumber of bad observations ALmeta.numbershortastrometric_n_good_obs_acNumber of good observations ACmeta.numbershortastrometric_n_good_obs_alNumber of good observations ALmeta.numbershortastrometric_chi2_alAstrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flagOnly primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colourColour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_alMean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisiblilty_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_maxThe longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observationsThe number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_usedType of prior used in in the astrometric solutionshortnullableastrometric_relegation_factorRelegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_acMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_alMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_sourceDuring data processing, this source happened to have been duplicated and one source only has been kept.shortra_dec_corrCorrelation between right ascension and declinationstat.correlationfloatnullablera_pmra_corrCorrelation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corrCorrelation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corrCorrelation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corrCorrelation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corrCorrelation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corrCorrelation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corrCorrelation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corrCorrelation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corrCorrelation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4Degree of concentration of scan directions across the sourcefloatnullablepriam_flagsFlags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flagsFlags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lowerLower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upperUpper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lowerLower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upperUpper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lowerLower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upperUpper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lowerLower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upperUpper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lowerLower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upperUpper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefehFe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullablemassInitial mass of the starsolMassphys.massfloatnullableageAge of the starGyrtime.agefloatnullableloggLogarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablenobsNominal number of observations, scaled to the shorter time base of GDR2 (a function with ecliptic latitude).meta.number;obsintindex_parsecForeign key into the photometry/extinction table.meta.id.crossintgdr2mock.photometryindex_parsecindex_parsec
gdr3specGaia DR3 RP/BP (XP) Monte Carlo sampled spectra +This is a re-publication the Gaia DR3 RP/BP spectra in the IVOA Spectral +Data Model. It presents the continous spectra in sampled form, using a +Monte Carlo scheme to decorrelate errors, elaborated in this resource's +reference URL. The underlying tables are also available for querying +through TAP, which opens some powerful methods for mass-analysing the data.gdr3spec.spectraMonte Carlo sampled DR3 XP spectraThis table contains the sampled spectra, their errors (as the standard +deviation of the samples between the different realisations), and the +Gaia DR3 source_id. Join this table on source_id with gaia.dr3lite to +obtain information on the sources.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryfluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gdr3spec.withposMonte Carlo Sampled DR3 XP Spectra with Basic Object InformationThis table contains the data from gdr3spec.spectra plus position and +photometry from gaia.dr3lite. It is a view, and there is generally no +advantage to using it instead of manually performing the join.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablefluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gdr3spec.ssametaSSA Metadata for the Monte Carlo-sampled Gaia DR3 XP spectra219196404phot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablesource_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablepreviewURL of a preview for the datasetmeta.ref.url;meta.previewcharnullableaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharnullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoublenullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperturedoublenullable
gedr3autoGaia eDR3 Autocorrelation This is a table that simply gives, for each object in Gaia eDR3, the +identifier of its closest neighbour together with the distance of the +pair.gedr3auto.main This is a table that simply gives, for each object in Gaia eDR3, the +identifier of its closest neighbour together with the distance of the +pair.1900000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimarypartner_idIdentifier of the closest eDR3 objectmeta.id.assoclongindexeddistThe estimated distance between the two objects. No attempt is made to furnish this with an error estimate.degpos.angDistancedoubleindexednullable
gedr3distGeometric and photogeometric distances to 1.47 billion stars in Gaia +Early Data Release 3 (eDR3) +We estimate the distance from the Sun to sources in Gaia eDR3 that have +parallaxes. We provide two types of distance estimate, together with +their corresponding asymmetric uncertainties, using Bayesian posterior +density functions that we sample for each source. Our prior is based +on a detailed model of the 3D spatial, colour, and magnitude +distribution of stars in our Galaxy that includes a 3D map of +interstellar extinction. + +The first type of distance estimate is purely geometric, in that it only +makes use of the Gaia parallax and parallax uncertainty. This uses a +direction-dependent distance prior derived from our Galaxy model. The +second type of distance estimate is photogeometric: in addition to +parallax it also uses the source's G-band magnitude and BP-RP +colour. This type of estimate uses the geometric prior together with a +direction-dependent and colour-dependent prior on the absolute magnitude +of the star. + +Our distance estimate and uncertainties are quantiles, so are invariant +under logarithmic transformations. This means that our median estimate +of the distance can be used to give the median estimate of the distance +modulus, and likewise for the uncertainties. + +For applications that cannot be satisfied through TAP, you can download +a `full table dump`_. + +.. _full table dump: /gedr3dist/q/download/formgedr3dist.main +We estimate the distance from the Sun to sources in Gaia eDR3 that have +parallaxes. We provide two types of distance estimate, together with +their corresponding asymmetric uncertainties, using Bayesian posterior +density functions that we sample for each source. Our prior is based +on a detailed model of the 3D spatial, colour, and magnitude +distribution of stars in our Galaxy that includes a 3D map of +interstellar extinction. + +The first type of distance estimate is purely geometric, in that it only +makes use of the Gaia parallax and parallax uncertainty. This uses a +direction-dependent distance prior derived from our Galaxy model. The +second type of distance estimate is photogeometric: in addition to +parallax it also uses the source's G-band magnitude and BP-RP +colour. This type of estimate uses the geometric prior together with a +direction-dependent and colour-dependent prior on the absolute magnitude +of the star. + +Our distance estimate and uncertainties are quantiles, so are invariant +under logarithmic transformations. This means that our median estimate +of the distance can be used to give the median estimate of the distance +modulus, and likewise for the uncertainties. + +For applications that cannot be satisfied through TAP, you can download +a `full table dump`_. + +.. _full table dump: /gedr3dist/q/download/form1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryr_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3dist.litewithdistGaia (e)DR3 lite distances subsetThis table joins the DR3 "lite" table +(consisting only of the columns necessary for the most basic +science) with the estimated geometric and photogeometric distances. +Note that this is an inner join, i.e., DR3 objects without +distance estimates will not show up here. + +Note: Due to current limitations of the postgres query planner, +this table cannot usefully be used in positional joins +("crossmatches"). See the `Tricking the query planner`_ example. + +.. _tricking the query planner: http://dc.g-vo.org/tap/examples#Trickingthequeryplanner1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullabler_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3mockGaia early DR3 Mock Catalogue (gedr3mock) This catalogue is a simulation of the Gaia EDR3 stellar content using +Galaxia (a tool to sample stars from a Besancon-like Milky Way model), +3d dust extinction maps and the latest PARSEC Isochrones. It is +mimicking the Gaia DR2 data model and an apparent magnitude limit of +G=20,7. Extinctions and photometry in different bands have also been +included in a supplementary table as well as uncertainty estimates +using scaled GDR2 errors. Additional magnitude limit per HEALpix maps +are provided, based on the mode in the magnitude distribution of Gaia +DR2 data.gedr3mock.parsec_propsParsec-based photometry and extinction for GeDR3 Mock This table is intended to augment the Gaia photometry of GeDR3 Mock +stars with other bands and extinctions (Sloan, Johnson and 2MASS). The +grid was generated by binning all isochrones in logg, teff, and feh +and taking the median values of all isochrone models that fall within +one bin. We also report the median values of some astrophysical +parameters so that one can check how far the actual star abundances +deviate from the bin's median. For the extinction we report the +extinction for the specific isochrone bin in a specific photometric +band for 6 different values of monochromatic extinction, A_0, i.e. +1,2,3,5,10,20 mag. + +Sometimes stars in GeDR3 Mock depart from the isochrone grid, because, +e.g., the feh value is outside of the grid or values have been +interpolated by Galaxia in the catalog generation from the Parsec +isochrones. Then the index_parsec is assigned to the nearest neighbour +in log_lum and log_teff.243238index_parsecThe primary key of the photometry table, useful for joining with index_parsec in gedr3mock.main. This has the format LLLTTTFFF indexing bins in log_lum, log_teff, feh in the parsec isochrones. To find the actual bin centers, see the log_lum, log_teff, and meh_ini columns.meta.refintindexedmeh_iniLog of initial model metalicity at the center of this bin.phys.abund.zfloatnullablelog_ageMedian log of model star age at the parsec bin.log(yr)time.agefloatnullablem_iniMedian of the initial (zero age) mass of all model stars in the parsec bin.solMassphys.massfloatnullablem_actMedian of the current (at log_age) mass of all model star in the parsec bin.solMassphys.massfloatnullablelog_lumMedian Log of luminosity of all model stars in the parsec bin.log(solLum)phys.luminosityfloatnullablelog_teffMedian Log of the effective temperature of all model stars in the parsec bin.log(K)phys.temperature.effectivefloatnullablelog_gravMedian Log of the surface gravity of all model stars in the parsec bin.log(m/s**2)phys.gravityfloatnullablegaia_gMedian absolute magnitude in the Gaia G band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablegaia_bpbrMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_bpftMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_rpMedian absolute magnitude in the Gaia RP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablegaia_rvsMedian absolute magnitude in the Gaia RVS band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_uMedian absolute magnitude in the Johnson U band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullableubv_bMedian absolute magnitude in the Johnson B band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullableubv_vMedian absolute magnitude in the Johnson V band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullableubv_rMedian absolute magnitude in the Johnson R band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_iMedian absolute magnitude in the Johnson I band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullableubv_jMedian absolute magnitude in the Johnson J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullableubv_hMedian absolute magnitude in the Johnson H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullableubv_kMedian absolute magnitude in the Johnson K band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullableubv_lMedian absolute magnitude in the Johnson L band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.3-4umfloatnullableubv_mMedian absolute magnitude in the Johnson M band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.4-8umfloatnullablesloan_uMedian absolute magnitude in the SDSS u band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullablesloan_gMedian absolute magnitude in the SDSS g band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablesloan_rMedian absolute magnitude in the SDSS r band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablesloan_iMedian absolute magnitude in the SDSS i band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullablesloan_zMedian absolute magnitude in the SDSS z band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullabletmass_jMedian absolute magnitude in the 2MASS J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullabletmass_hMedian absolute magnitude in the 2MASS H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullabletmass_ksMedian absolute magnitude in the 2MASS K' band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullablea0_1_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_1_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_1_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_2_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_2_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_2_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_3_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_3_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_3_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_5_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_5_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_5_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_10_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_10_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_10_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_20_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_20_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_20_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullable
gedr3mock.generated_dataThis contains the data actually generated. Users probably want to use +the gdr2mock.main table that (fairly well) follows the Gaia DR2 data +model.1600000000teffeffective TemperatureKfloatfehlog of metallicity in solar units ('dex')floata0monochramatic Extinction at lambda=547.7nmmagfloatlumStellar luminositysolLumfloatlGalactic longitudedegdoublebGalactic latitudedegdoublesmassinitial mass in solar massessolMassfloatageAge of the starGyrfloatloggSurface gravity of starlog(cm/(s**2))floatphot_g_mean_magapparent G mag including extinctionmagfloatindexedphot_bp_mean_magapparent BP mag including extinctionmagfloatindexedphot_rp_mean_magapparent RP mag including extinctionmagfloatindexedphot_rvs_mean_magapparent RVS mag including extinctionmagfloatpopidPopulation ID according to the Besancon model. Including SMC/LMC = 10 and stellar clusters = 11shortmactactual (present) mass in solar massessolMassfloatphot_g_mean_mag_errorerror in Gmagfloata_gExtinction in Gmagfloata_bpExtinction in BPmagfloata_rpExtinction in RPmagfloata_rvsExtinction in RVSmagfloatparallaxparallax in masmasfloatindexedradial_velocityRadial velocity in km/skm/sfloatpm_raProper motion in projection of right ascensionmas/yrfloatpm_decProper motion in declinationmas/yrfloatparallax_errorparallax uncertainty in masmasfloatradial_velocity_errorRadial velocity uncertainty in km/skm/sfloatphot_g_n_obsNumber of photometric observations (trained from DR2 scaled to DR3 time)shortvisibility_periods_usedNumber of observations effectively used for the astrometric solutions (trained from DR2 scaled to DR3)shortsource_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table, .meta.id.crossintindexedrandom_indexRandom index that can be used to deterministically select subsetsintindexedd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshort
gedr3mock.mainA synthetic Milky Way catalog mimicking Gaia EDR3 in stellar content +and data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoublenullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoublenullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_mag[GeDR3mock only] apparent magnitude of the RVS band.magphot.color;em.opt.Ifloatnullablephot_g_mean_mag_error[GeDR3mock only] G mag error approximated by the symmetrised flux error.magphot.color;em.opt.Vfloatnullablephot_bp_mean_mag_error[GeDR3mock only] BP mag error (generated by scaling the G mag error with an empirical factor of 19.854 derived from GDR2).magphot.color;em.opt.Bfloatnullablephot_rp_mean_mag_error[GeDR3mock only] RP mag error (generated by scaling the G mag error with an empirical factor of 9.1205 derived from GDR2).magphot.color;em.opt.Rfloatnullablephot_rvs_mean_mag_error[GeDR3mock only] RVS mag error (generated by scaling the G mag error with with 30; this is essentially a wild guess which is probably too low if RVS magnitudes are provided at all).magphot.color;em.opt.Rfloatnullablerv_nb_transits[NULL] Number of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epoch[NULL] Reference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_q[NULL] Hipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noise[NULL] Excess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sig[NULL] Significance of excess noisestat.valuefloatnullableastrometric_n_obs_ac[NULL ]Total number of observations ACmeta.numbershortastrometric_n_obs_al[NULL] Total number of observations ALmeta.numbershortastrometric_n_bad_obs_ac[NULL] Number of bad observations ACmeta.numbershortastrometric_n_bad_obs_al[NULL] Number of bad observations ALmeta.numbershortastrometric_n_good_obs_ac[NULL] Number of good observations ACmeta.numbershortastrometric_n_good_obs_al[NULL] Number of good observations ALmeta.numbershortastrometric_chi2_al[NULL] Astrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flag[NULL] Only primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colour[NULL] Colour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_al[NULL] Mean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisibility_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_max[NULL] The longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observations[NULL] The number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_used[NULL] Type of prior used in in the astrometric solutionshortnullableastrometric_relegation_factor[NULL] Relegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_ac[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_al[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_source[NULL] During data processing, this source happened to have been duplicated and one source only has been kept.shortd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshortra_dec_corr[NULL] Correlation between right ascension and declinationstat.correlationfloatnullablera_pmra_corr[NULL] Correlation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corr[NULL] Correlation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corr[NULL] Correlation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corr[NULL] Correlation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corr[NULL] Correlation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corr[NULL] Correlation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corr[NULL] Correlation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corr[NULL] Correlation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corr[NULL] Correlation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4[NULL] Degree of concentration of scan directions across the sourcefloatnullablepriam_flags[NULL] Flags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flags[NULL] Flags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lower[Null] Lower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upper[Null] Upper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_bp_valEstimate of the line-of-sight extinction in the BP-band from Apsis-Priammagphys.absorptionfloatnullablea_bp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_bp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rp_valEstimate of the line-of-sight extinction in the RP-band from Apsis-Priammagphys.absorptionfloatnullablea_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rvs_valEstimate of the line-of-sight extinction in the RVS-band from Apsis-Priammagphys.absorptionfloatnullablea_rvs_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rvs_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lower[Null] Lower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upper[Null] Upper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lower[Null] Lower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upper[Null] Upper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefeh[GeDR3mock only] Fe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0[GeDR3mock only] Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullableinitial_mass[GeDR3mock only] Initial mass of the starsolMassphys.massfloatnullablecurrent_mass[GeDR3mock only] Current mass of the starsolMassphys.massfloatnullableage[GeDR3mock only] Age of the starGyrtime.agefloatnullablelogg[GeDR3mock only] Logarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablepopid[GeDR3mock only] Population ID according to the Besancon model. 10=SMC/LMC, 11=stellar clusterssrc.classshortpm_total[GeDR3mock only] Total proper motion of the star, i.e., sqrt(pmra^2+pmdec^2).mas/yrpos.pmfloatnullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table.meta.id.crossintindexedgedr3mock.parsec_propsindex_parsecindex_parsec
gedr3mock.maglim_5 +This table gives empirical magnitude limits for +G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels +of 5 (scale roughly ~2 degrees). For each band +we have 4 different variants: + +(1) no additional condition, +(2) parallax available, +(3) BP-RP available, +(4) parallax and BP-RP available. + +For BP mag limits we also require that BP is available. The magnitude +limits are approximated by the mode of the magnitude distribution in a +specific HEALpix. Since this mode estimator is prone to Poisson noise +in low density areas we report the magnitude limits in two flavours: + +(a) directly the mode estimator +(b) the same as the mode estimator, + +except that in healpixel with a stellar density below 1e5 sources per +square degree the limit is arbitrarily set to 20.7 mag. These magnitude +limits were created using the `gdr2_completeness package`_ and users +are encouraged to create custom-made magnitude limits with specific +conditions, e.g. RVS sample with good parallaxes. + +.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness12288hpxLevel 5 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3mock.maglim_6 +This table gives empirical magnitude limits for +G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels +of 6 (scale roughly ~1 degrees). For each band +we have 4 different variants: + +(1) no additional condition, +(2) parallax available, +(3) BP-RP available, +(4) parallax and BP-RP available. + +For BP mag limits we also require that BP is available. The magnitude +limits are approximated by the mode of the magnitude distribution in a +specific HEALpix. Since this mode estimator is prone to Poisson noise +in low density areas we report the magnitude limits in two flavours: + +(a) directly the mode estimator +(b) the same as the mode estimator, + +except that in healpixel with a stellar density below 1e5 sources per +square degree the limit is arbitrarily set to 20.7 mag. These magnitude +limits were created using the `gdr2_completeness package`_ and users +are encouraged to create custom-made magnitude limits with specific +conditions, e.g. RVS sample with good parallaxes. + +.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness49152hpxLevel 6 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3mock.maglim_7 +This table gives empirical magnitude limits for +G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels +of 7 (scale roughly ~0.5 degrees). For each band +we have 4 different variants: + +(1) no additional condition, +(2) parallax available, +(3) BP-RP available, +(4) parallax and BP-RP available. + +For BP mag limits we also require that BP is available. The magnitude +limits are approximated by the mode of the magnitude distribution in a +specific HEALpix. Since this mode estimator is prone to Poisson noise +in low density areas we report the magnitude limits in two flavours: + +(a) directly the mode estimator +(b) the same as the mode estimator, + +except that in healpixel with a stellar density below 1e5 sources per +square degree the limit is arbitrarily set to 20.7 mag. These magnitude +limits were created using the `gdr2_completeness package`_ and users +are encouraged to create custom-made magnitude limits with specific +conditions, e.g. RVS sample with good parallaxes. + +.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness196608hpxLevel 7 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3spurA classifier for spurious astrometric solutions in Gaia EDR3 This table contains estimates of the "fidelity" of Gaia eDR3 +astrometric solutions, a measure of the likelihood the eDR3 solution +is physical rather than spurious obtained using a neural network +trained on a small, hand-selected sample.gedr3spur.main This table contains estimates of the "fidelity" of Gaia eDR3 +astrometric solutions, a measure of the likelihood the eDR3 solution +is physical rather than spurious obtained using a neural network +trained on a small, hand-selected sample.1500000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryfidelity_v2A probability that eDR3 has a good astrometric solution for this source, with values between 0 (meaning likely spurious solution) and 1 (meaning likely good solution). This is the published probability estimate.stat.fitfloatindexednullabletheta_arcsec_worst_sourceDistance to the eDR3 source within 30 arcsec of the object for which ΔG-θ is maximal. See norm_dg for details.arcsecpos.angDistancefloatnullablenorm_dgThis is a heuristic measure for contamination by bright stars in the neighbourhood. It is computed as ΔG-θ, where θ is the distance to another Gaia eDR3 object in arcsec (reported in theta_arcsec_worst_source), and ΔG is the magnitude difference in mag. This column gives the maximum of the values for all eDR3 sources within 30 arcsecs of the object.instr.backgroundfloatnullabledist_nearest_neighbor_at_least_m2_brighterDistance to the nearest neighbour in gaia_source at least 2 m fainter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_0_brighterDistance to the nearest neighbour in gaia_source at least as bright as this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_2_brighterDistance to the nearest neighbour in gaia_source at least 2 m brighter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_4_brighterDistance to the nearest neighbour in gaia_source at least 4 m brighter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_6_brighterDistance to the nearest neighbour in gaia_source at least 6 m brighter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_10_brighterDistance to the nearest neighbour in gaia_source at least 10 m brighter than this source.arcsecpos.angDistancefloatnullablefidelity_v1A probablity that eDR3 has a good astrometric solution for this source, with values between 0 (meaning likely spurious solution) and 1 (meaning likely good solution). This comes from a first version of the estimator that was reviewed based on an astro-ph paper.stat.fitfloatnullable
glotsGloTS, the Global TAP Schema +The global TAP schema collects information on +tables and columns from known TAP servers. This facilitates locating +queriable data by physics (via UCD) or keywords (via description). + +Note that this shouldn't really be necessary as all information +present here should be exposed through Registry records. However, +in reality data providers currently are much more liable to give +column metadata in their tap_schema than in their Registry records. +Hence, for the time being, we maintain this service by harvesting +tap_schemas about monthly.glots.servicesA table of TAP services harvested from the registry (and some +spoon-fed).ivoidIVOA identifier of providing servicecharindexedprimaryaccessurlBase URL of TAP endpointcharnullablenextharvestNext scheduled harvest of datacharnullableharvestintervalApproximate interval of harvestdintnullablelastsuccessLast successful harvest of this servicecharnullable
glots.tablesA table of tables accesible through the TAP services known to +glots.services.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarytable_descBrief description of the tableunicodeCharindexednullableutypeutype if the table corresponds to a data modelcharnullableglots.servicesivoidivoid
glots.columnsA table of columns within the tables listed in glots.tables.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columncharindexednullableunitUnit in VO standard formatcharnullableucdUCD of column (some services still have 1.0 UCDs).charindexednullableutypeUtype of columncharnullabledatatypeADQL datatypecharnullable"size"Length of variable length datatypesintnullableprincipalIs column principal?charnullableindexedIs there an index on this column?intnullablestdIs this a standard column?charnullableglots.tablesivoidivoidtable_nametable_name
gps1The Gaia-PS1-SDSS (GPS1) Proper Motion Catalog +This catalog combines Gaia DR1, Pan-STARRS 1, SDSS and 2MASS astrometry +to compute proper motions for 350 million sources across three-fourths of +the sky down to a magnitude of mr≈20. Positions of galaxies from Pan-STARRS 1 +are used to build a reference frame for PS1, SDSS, and 2MASS data. +Gaia DR1 is adapted to that reference frame by exploiting that locally, +proper motions are linear. + +GPS1 has a characteristic systematic error of less than 0.3 mas/yr, and +a typical precision of 1.5−2.0 mas/yr. The proper motions have been +validated using galaxies, open clusters, distant giant stars and QSOs. In +comparison with other published faint proper motion catalogs, GPS1's +systematic error (<0.3 mas/yr) is about 10 times better than that of PPMXL +and UCAC4 (>2.0 mas/yr). Similarly, its precision (~1.5 mas/yr) is +an improvement by ∼ 4 times relative to PPMXL and UCAC4 (∼6.0 mas/yr). +For QSOs, the precision of GPS1 is found to be worse (∼2.0−3.0 mas/yr), +possibly due to their particular differential chromatic refraction (DCR).gps1.mainGPS1 main table with some deviations from the published paper. In +particular note that Gaia and Pan-STARRS1 photometry results from +blind crossmatching; see d_g and d_ps1 fields for the offsets in the +respective crossmatches.350000000obj_idUnique object identifier (this is not the Pan-STARRS1 identifier).meta.id;meta.mainlongindexedraRight Ascension from fit (ICRS, Epoch J2010).degpos.eq.ra;meta.maindoubleindexednullabledecDeclination from fit (ICRS, Epoch J2010).degpos.eq.dec;meta.maindoubleindexednullablee_raError in Right Ascension from Gaia DR1.degstat.error;pos.eq.ra;meta.mainfloatnullablee_decError in Declination from Gaia DR1.degstat.error;pos.eq.dec;meta.mainfloatnullablera_ps1Right Ascension from Pan-STARRS1degpos.eq.radoublenullabledec_ps1Declination from Pan-STARRS1degpos.eq.decdoublenullablepmraProper motion in RA with cos(δ) applied; robust fit.deg/yrpos.pm;pos.eq.rafloatnullablee_pmraError of proper motion in RA, cos(δ) applied; robust fit.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declination; robust fit.deg/yrpos.pm;pos.eq.decfloatnullablee_pmdeError of proper motion in Declination; robust fit.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmra_xProper motion in RA with cos(δ) applied; x-validation fit.deg/yrpos.pm;pos.eq.rafloatnullablee_pmra_xError of proper motion in RA, cos(δ) applied; x-validation fit.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmde_xProper motion in Declination; x-validation fit.deg/yrpos.pm;pos.eq.decfloatnullablee_pmde_xError of proper motion in Declination; x-validation fit.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmra_ngProper motion in RA with cos(δ) applied; fit without Gaia.deg/yrpos.pm;pos.eq.rafloatnullablee_pmra_ngError of proper motion in RA, cos(δ) applied; fit without Gaia.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmde_ngProper motion in Declination; fit without Gaia.deg/yrpos.pm;pos.eq.decfloatnullablee_pmde_ngError of proper motion in Declination; fit without Gaia.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmra_psProper motion in RA with cos(δ) applied; fit with only Pan-STARRS.deg/yrpos.pm;pos.eq.rafloatnullablee_pmra_psError of proper motion in RA, cos(δ) applied; fit with only Pan-STARRS.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmde_psProper motion in Declination; fit with only Pan-STARRS.deg/yrpos.pm;pos.eq.decfloatnullablee_pmde_psError of proper motion in Declination; fit with only Pan-STARRS.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablechi2pmraReduced χ² for the robust fit of proper motion in RAstat.fit.chi2;pos.pm;pos.eq.rafloatnullablechi2pmdeReduced χ² for the robust fit of proper motion in Declinationstat.fit.chi2;pos.pm;pos.eq.decfloatnullablechi2pmra_psReduced χ² for the Pan-STARRS 1-only fit of proper motion in RAstat.fit.chi2;pos.pm;pos.eq.rafloatnullablechi2pmde_psReduced χ² for the Pan-STARRS 1-only fit of proper motion in Declinationstat.fit.chi2;pos.pm;pos.eq.decfloatnullablemaggg-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Vfloatnullablee_maggError in g-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Vfloatnullablemagrr-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Rfloatnullablee_magrError in r-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Rfloatnullablemagii-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Ifloatnullablee_magiError in i-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Ifloatnullablemagzz-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Ifloatnullablee_magzError in z-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Ifloatnullablemagyy-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Ifloatnullablee_magyError in y-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.IfloatnullablemagjJ-band magnitude from 2MASSmagphot.mag;em.ir.Jfloatnullablee_magjError in J-band magnitude from 2MASSmagstat.error;phot.mag;em.ir.JfloatnullablemaghH-band magnitude from 2MASSmagphot.mag;em.ir.Hfloatnullablee_maghError in H-band magnitude from 2MASSmagstat.error;phot.mag;em.ir.HfloatnullablemagkK_s-band magnitude from 2MASSmagphot.mag;em.ir.Kfloatnullablee_magkError in K_s-band magnitude from 2MASSmagstat.error;phot.mag;em.ir.KfloatnullablemaggaiaG-band magnitude from Gaiamagphot.mag;em.opt.Vfloatnullablee_maggaiaError in G-band magnitude from Gaiamagstat.error;phot.mag;em.opt.Vfloatnullablen_obsps1Number of PS1 SeasonAVG detections.meta.number;obsshortn_obsnumber of all the detections.meta.number;obsshortsurveysSum of source codes for the source catalogues that went into this row. Pan-STARRS is always present. Source codes: 5 -- 2MASS; 10 -- SDSS, 20 -- Gaia.meta.codeshortd_ps1Distance between position in GPS1 and the associated (closest) position in Pan-STARRS1 used for (not accounting for the epoch difference).arcsecpos.eq;arith.difffloatnullabled_gDistance between position in GPS1 and the associated (closest) position in Gaia DR1 (not accounting for the epoch difference).arcsecpos.eq;arith.difffloatnullable
hdgaiaThe Henry Draper Catalog with Gaia IDs This is the Henry Draper catalog (HD, Cannon & Pickering 1918-1924) +as distributed by the Astronomical Data Center in 1989 (Vizier +III/135A), with Gaia DR2 source_ids and positions added. The link to +modern Gaia DR2 was done through Fabricius et al's match between HD +and Tycho 2 (Vizier IV/25), TGAS to match Tycho 2 and Gaia DR1, and +Gaia DR2 to match against Gaia DR1.hdgaia.main This is the Henry Draper catalog (HD, Cannon & Pickering 1918-1924) +as distributed by the Astronomical Data Center in 1989 (Vizier +III/135A), with Gaia DR2 source_ids and positions added. The link to +modern Gaia DR2 was done through Fabricius et al's match between HD +and Tycho 2 (Vizier IV/25), TGAS to match Tycho 2 and Gaia DR1, and +Gaia DR2 to match against Gaia DR1.272150hdHD number for this objectmeta.id;meta.mainintindexedprimarydmDurchmusterung identifier, taken either from the Bonner Durchmusterung (BD), Cordoba Durchmusterung (CD), or Cape Photographic Durchmusterung (CPD); stars not given in any of them are referenced by their AGK number.meta.id.crosscharnullablera_origOriginal right ascension for equinox J1900.0. Note that this position is only good to about an arcminute.pos.eq.racharnullabledec_origOriginal declination for equinox J1900.0. Note that this position is only good to about an arcminute.pos.eq.deccharnullablera_orig_2000Original right ascension for equinox J2000.0 (precession done by DC staff). Note that this position is only good to about an arcminute.pos.eq.rafloatnullabledec_orig_2000Original declination for equinox J2000.0 (precession done by DC staff). Note that this position is only good to about an arcminute.pos.eq.decfloatnullablemv_meas'0' if the m_v is a measured value, '1' if it's a value inferred from m_pg and the spectral type.meta.codecharm_vPhotovisual magnitude or the star, except for magnitudes >= 20, which are object type flags (see note).magphot.mag;em.opt.Vfloatindexednullablemv_combC if m_v is a combined magnitude (with a neighbouring star given in this catalogue), NULL otherwise.meta.codecharnullablempg_meas'0' if the m_pg is a measured value, '1' if it's a value inferred from m_v and the spectral type.meta.codecharm_pgPhotographic magnitude or the star, except for magnitudes >= 20, which are object type flags (see note).magphot.mag;em.opt.Bfloatnullablempg_combC if m_pg is a combined magnitude (with a neighbouring star given in this catalogue), NULL otherwise.meta.codecharnullablespectralSpectral type, given in upper and lower case as in the published catalog.src.sptypecharindexednullablepg_intensityPhotographic intensity of the spectrum estimated by Annie Cannon. The faintest spectra which could be classified with certainty were assigned a value of 1, while the densest are given as 10. For stars having two intensities in the published catalog, only the first is given here.meta.code.qualshortnullableremarksRemarks. See note for what the letters mean.meta.codecharnullablen_hdNumber of HD stars matched to a Tycho 2 source by Fabricius et al, 2002A&A...386..709F.meta.numbershortnullablen_tycNumber of Tycho 2 stars matched to a HD source by Fabricius et al, 2002A&A...386..709F.meta.numbershortnullablesource_idGaia DR2 source_id matching the HD object through Fabricius' Tycho 2 match and Gaia DR2's tycho2_best_neighbour. For four ambiguous matches, a unique match was randomly chosen (see reference URL).meta.id.crosslongnullablesource_id3Gaia eDR3 source_id matching the HD object through Fabricius' Tycho 2 match and Gaia DR2's tycho2_best_neighbour, and then Gaia eDR3's dr2_best_neighbour.meta.id.crosslongnullablegaia_raICRS Right Ascension from Gaia eDR3 (i.e., Epoch J2016)degpos.eq.ra;meta.maindoubleindexednullablegaia_decICRS Declination from Gaia eDR3 (i.e., Epoch J2016)degpos.eq.dec;meta.maindoubleindexednullable
hiicounterReference HII Regions for Abundance Determination A table containing reference data for HII regions. We also give a +source code to compute abundances and electron temperatures in HII +regions from strong emission lines.hiicounter.data A table containing reference data for HII regions. We also give a +source code to compute abundances and electron temperatures in HII +regions from strong emission lines.414identIdentifier of the HII region in this catalogmeta.id;meta.mainintlogr3Log of [OIII] R_3 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullablelogr2Log of [OII] R_2 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullablelogn2Log of [NII] N_2 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullablelogs2Log of [SII] S_2 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullableo_hT_e-based oxygen abundance given as 12+log(O/H)phys.abund;arith.ratiofloatnullablen_hT_e-based nitrogen abundance given as 12+log(N/H)phys.abund;arith.ratiofloatnullablet3Electron temperature derived as given in t3src, reduced to t_3([O III])Kphys.temperature.electronfloatnullablet3srcLines used for determination of t_3meta.code;phys.temperature.electroncharnullableregion_nameName of the HII region.meta.id;srccharnullablesrcReference to the source of the data quoted.meta.bib.bibcodecharnullablehostalphaICRS RA of host object (from Simbad)pos.eq.ra;meta.mainfloatindexednullablehostdeltaICRS Dec of host object (from Simbad)pos.eq.dec;meta.mainfloatindexednullable
hipparcosHipparcos CatalogueThe main result catalog from the ESA Hipparcos satellite, obtained +November 1989 through March 1993. In the GAVO DC, several columns were +left out and all angles are given in degrees.hipparcos.mainThe main result catalog from the ESA Hipparcos satellite, obtained +November 1989 through March 1993. In the GAVO DC, several columns were +left out and all angles are given in degrees.117955hipnoIdentifier (HIP number)meta.id;meta.mainintindexedprimaryraRight ascension ICRS (Epoch J1991.25)degpos.eq.ra;meta.maindoubleindexeddecDeclination ICRS (Epoch J1991.25)degpos.eq.dec;meta.maindoubleindexedvmagMagnitude in Johnson Vmagphot.mag;em.opt.VfloatnullablevarflagCoarse variability flagmeta.code;src.varbooleanwhatposPosition is for -- A-Z: multiple component, *: Photocenter, +: Center of massmeta.notecharnullableparallaxTrigonometric parallaxdegpos.parallax.trigfloatnullablepmraProper motion in RA, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decdoublenullablee_radegStandard error in RA*cos(delta)degstat.errorfloatnullablee_dedegStandard error in DEdegstat.errorfloatnullablee_parallaxStandard error of parallaxdegstat.errorfloatnullablee_pmraStandard error in PM in RAdeg/yrstat.errorfloatnullablee_pmdeStandard error in PM in Decdeg/yrstat.errorfloatnullablef2Goodness-of-fit parameter, >3 means bad datastat.fit.goodnessfloatnullablehpmagMedian magnitude in Hipparcos systemmagphot.mag;em.opt.Vfloatnullablee_hpmagStandard error on median magnitudemagstat.errorfloatnullablehpscatScatter on median magnitudemagphot.mag;em.opt.Vfloatnullableo_hpmagNumber of observations in median magnitudemeta.numbershortnullablewhatmagMag is for -- A-Z: multiple component, *: combined and corrected for attenuation, +: combined and not corrected for attenuationmeta.code.multipcharnullablehpmaxHpmag at maximum (5th percentile)magphot.mag;em.opt.VfloatnullablehpminHpmag at minimum (95th percentile)magphot.mag;em.opt.VfloatnullableperiodVariability periodstime.periodfloatnullablesptypeSpectral type from various sourcessrc.spTypecharnullablemultflagMultiplicity flag, see note.meta.code.multipcharnullablebinpaPosition angle between componentsdegpos.posAng;src.orbitalfloatnullablebinsepAngular separation between componentsarcsecpos.angDistance;src.orbitalfloatnullablebinseperrStandard error on ang. separationarcsecstat.error;pos.angDistance;src.orbitalfloatnullablemagdiffMagnitude difference of componentsmagphot.mag;arith.difffloatnullable
hppunionGAVO Historical Photographic Plate Archive GHPPA +GAVO's historical photographic plate archive (GHHPA) is a +collection of various digitized historical photographic +plates. It currently exposes: + +* the scans of plates of selected Kapteyn special fields obtained + at Potsdam +* the Palomar-Leiden Trojan surveys, 1960-1977, +* a collection of plates obtained at Boyden Station, South Africa, + kept at various German observatories. + +Other plate collections kept by GAVO include the Heidelberg +Digitized Astronomical Plates HDAP, +ivo://org.gavo.dc/lswscans/res/positions/siap, and the APPLAUSE +database from Potsdam.hppunion.main +GAVO's historical photographic plate archive (GHHPA) is a +collection of various digitized historical photographic +plates. It currently exposes: + +* the scans of plates of selected Kapteyn special fields obtained + at Potsdam +* the Palomar-Leiden Trojan surveys, 1960-1977, +* a collection of plates obtained at Boyden Station, South Africa, + kept at various German observatories. + +Other plate collections kept by GAVO include the Heidelberg +Digitized Astronomical Plates HDAP, +ivo://org.gavo.dc/lswscans/res/positions/siap, and the APPLAUSE +database from Potsdam.1897accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableobjectObject being observed, Simbad-resolvable formmeta.idcharnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharnullabledatalink_urlURL of a datalink document (cutout service, ancillary data) for this dataset.charnullable
hsoyThe HSOY Catalog +HSOY is a catalog of 583'001'653 objects with precise astrometry based on +PPMXL and Gaia DR1. Typical formal errors at mean epoch in proper motion are +below 1 mas/yr for objects brighter than 10 mag, and about 5 mas/yr at the +faint end (about 20 mag). South of -30 degrees, astrometry is significantly +worse. HSOY also contains, where available, USNO-B, Gaia, and 2MASS +photometry. HSOY's positions and proper motions are given for epoch J2000. +The catalog becomes severely incomplete faintwards of 16 mag in the G-band. +The mean epochs are typically very close to Gaia's J2015. + +HSOY still contains about 0.7% spurious close +"binaries" (non-matched stars) from the original USNO-B (marked with non-NULL +clone). Also, failed matches within Gaia DR1 contribute another 1.5% spurious +pairs (marked with non-NULL comp). In both cases, astrometry presumably is +sub-standard. + +More information is available at http://dc.g-vo.org/hsoy.hsoy.mainHsoy Object Catalog +HSOY is a catalog of 583'001'653 objects with precise astrometry based on +PPMXL and Gaia DR1. Typical formal errors at mean epoch in proper motion are +below 1 mas/yr for objects brighter than 10 mag, and about 5 mas/yr at the +faint end (about 20 mag). South of -30 degrees, astrometry is significantly +worse. HSOY also contains, where available, USNO-B, Gaia, and 2MASS +photometry. HSOY's positions and proper motions are given for epoch J2000. +The catalog becomes severely incomplete faintwards of 16 mag in the G-band. +The mean epochs are typically very close to Gaia's J2015. + +HSOY still contains about 0.7% spurious close +"binaries" (non-matched stars) from the original USNO-B (marked with non-NULL +clone). Also, failed matches within Gaia DR1 contribute another 1.5% spurious +pairs (marked with non-NULL comp). In both cases, astrometry presumably is +sub-standard. + +More information is available at http://dc.g-vo.org/hsoy.590000000ipixThe PPMXL object identifier, which in turn is the q3c ipix of the original USNO-B object; for HSOY, only (ipix, comp) is a unique identifier (primary key). The recommended identifier form is 'HSOY ipix.comp', where comp=0 for NULL comps. This is what the SCS generates.meta.id.crosslongindexedcompIf non-null this indicates that multiple Gaia objects matched the PPMXL object; this may indicate bona fide multiple stars, but more likely is due to failed matching of Gaia observations at different epochs. In both cases, proper motions must be used with care. The index is artificial, i.e., no primary, secondary, etc, is implied. ipix+comp together are a primary key to hsoy.main.meta.code.multipshortnullableraj2000Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablee_raepraMean error in RA*cos(delta) at mean epochdegstat.error;pos.eq.ra;meta.mainfloatnullablee_deepdeMean error in Dec at mean epochdegstat.error;pos.eq.dec;meta.mainfloatnullablepmraProper Motion in RA*cos(delta)deg/yrpos.pm;pos.eq.rafloatnullablepmdeProper Motion in Decdeg/yrpos.pm;pos.eq.decfloatnullablee_pmraMean error in pmRA*cos(delta)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error in pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullableepraMean Epoch (RA)yrtime.epoch;pos.eq.rafloatnullableepdeMean Epoch (Dec)yrtime.epoch;pos.eq.decfloatnullablejmagJ selected default magnitude from 2MASSmagphot.mag;em.IR.Jfloatindexednullablee_jmagJ total magnitude uncertaintymagstat.error;phot.mag;em.IR.JfloatnullablehmagH selected default magnitude from 2MASSmagphot.mag;em.IR.Hfloatnullablee_hmagH total magnitude uncertaintymagstat.error;phot.mag;em.IR.HfloatnullablekmagK_s selected default magnitude from 2MASSmagphot.mag;em.IR.Kfloatindexednullablee_kmagK_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullableb1magB mag from USNO-B, first epochmagphot.mag;em.opt.Bfloatnullableb2magB mag from USNO-B, second epochmagphot.mag;em.opt.Bfloatnullabler1magR mag from USNO-B, first epochmagphot.mag;em.opt.Rfloatnullabler2magR mag from USNO-B, second epochmagphot.mag;em.opt.RfloatnullableimagI mag from USNO-Bmagphot.mag;em.opt.IfloatnullablemagsurveysSurveys the USNO-B magnitudes are taken frommeta.codecharnullablenobsNumber of observations contributing to this column (always nobs(ppmxl)+1)meta.number;obsshortnullablegaia_idUnique source identifiermeta.idlongindexednullablephot_g_mean_magMean magnitude in the G band from Gaia DR1. Magnitudes for which err_flux/flux>0.1 have been dropped.magphot.mag;em.opt;stat.meanfloatindexednullablee_phot_g_mean_magEstimated error in Gaia G-band magnitude. This is estimated as 1.09*err_flux/flux which is good as a symmetric 1 σ-error of the magnitude to at least within a few percent when err_flux/flux is smaller than 0.1, as it is for the HSOY objects.s**-1stat.error;phot.mag;em.opt.VfloatnullablecloneIf 1, more than one PPMXL object matched to this Gaia object (i.e.: proper motion is probably wrong, any apparent duplicity is probably spurious). This is normally due to failed matching of objects from different plates in USNO-B.meta.code.qualshortnullableno_sc1 if this object had no match within 3 arcseconds in SuperCosmos at J2000. It is very likely that it is not a real object. NOTE: False is encoded as NULL in the database; to exclude objects without a supercosmos match, write no_sc IS NULL.meta.code.qualshortnullable
icecubeIceCube-40 neutrino candidatesA list of neutrino candidate events recorded by the IceCube neutrino +telescope operating in a 40 string configuration between April 2008 +and May 2009.icecube.nucand Detection parameters of neutrino candidates recorded by the IceCube +Neutrino Observatory. This table can be queried on web at +http://dc.g-vo.org/icecube/q/web .12876evidGAVO-local event id, IAU-formatmeta.id;meta.maincharindexedprimarynualphaNeutrino arrival direction, RAdegpos.eq.ra;meta.mainfloatnudeltaNeutrino arrival direction, Declinationdegpos.eq.dec;meta.mainfloatmuelossEstimated muon energy loss in iceGeV/mphys.absorptionfloatmueEstimated muon energy at closest distance to the center of the IceCube detectorGeVphys.energyfloatnchNumber of optical modules hit in an eventmeta.numbershortmjdObservation time, Modified Julian Daytime.epoch;obsfloat
inflightThe Endless LightcurveThe infinite lightcurve is a continuously calculated microlensing +lightcurve, simulating the light variation of a quasar due to an +intervening star field.inflight.dataThe raw lensing data as well as relative intensities computed for +various source profiles.1200000lineDistance indicator in 0.01 Einstein radiipos.distanceintindexeddataBase64 encoded 8-bit image datacharnullablesrcnameName of file this line came frommeta.refcharnullablegauss01Magnification for a Gauss disk source with r=1magphot.mag;arith.difffloatnullablegauss02Magnification for a Gauss disk source with r=2magphot.mag;arith.difffloatnullablegauss04Magnification for a Gauss disk source with r=4magphot.mag;arith.difffloatnullablegauss06Magnification for a Gauss disk source with r=6magphot.mag;arith.difffloatnullablegauss08Magnification for a Gauss disk source with r=8magphot.mag;arith.difffloatnullablegauss10Magnification for a Gauss disk source with r=10magphot.mag;arith.difffloatnullablegauss12Magnification for a Gauss disk source with r=12magphot.mag;arith.difffloatnullablegauss16Magnification for a Gauss disk source with r=16magphot.mag;arith.difffloatnullablegauss20Magnification for a Gauss disk source with r=20magphot.mag;arith.difffloatnullablegauss24Magnification for a Gauss disk source with r=24magphot.mag;arith.difffloatnullablegauss28Magnification for a Gauss disk source with r=28magphot.mag;arith.difffloatnullablegauss32Magnification for a Gauss disk source with r=32magphot.mag;arith.difffloatnullablegauss40Magnification for a Gauss disk source with r=40magphot.mag;arith.difffloatnullablegauss48Magnification for a Gauss disk source with r=48magphot.mag;arith.difffloatnullablethin01Amplification of a thin disk of r=1magphot.mag;arith.diff;meta.mainfloatnullablethin02Magnification for thin disk with r=2magphot.mag;arith.difffloatnullablethin04Magnification for thin disk with r=4magphot.mag;arith.difffloatnullablethin06Magnification for thin disk with r=6magphot.mag;arith.difffloatnullablethin08Magnification for thin disk with r=8magphot.mag;arith.difffloatnullablethin10Magnification for thin disk with r=10magphot.mag;arith.difffloatnullablethin12Magnification for thin disk with r=12magphot.mag;arith.difffloatnullablethin16Magnification for thin disk with r=16magphot.mag;arith.difffloatnullablethin20Magnification for thin disk with r=20magphot.mag;arith.difffloatnullablethin24Magnification for thin disk with r=24magphot.mag;arith.difffloatnullablethin28Magnification for thin disk with r=28magphot.mag;arith.difffloatnullable
ivoaDefinition and support code for the ObsCore data model and table.ivoa.obs_radioAn IVOA-defined metadata table for radio measurements, with extra +metadata for interferometric measurements ("visibilities") as well as +single-dish observations. You will almost always want to join this +table to ivoa.obscore (do a natural join).ivo://ivoa.net/std/ObsRadio#table-1.0obs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexedprimarys_resolution_minAngular resolution, longest baseline and max frequency dependentarcsecpos.angResolution;stat.minChar.SpatialAxis.Resolution.Bounds.Limits.LoLimfloatnullables_resolution_maxAngular resolution, longest baseline and min frequency dependentarcsecpos.angResolution;stat.maxChar.SpatialAxis.Resolution.Bounds.Limits.HiLimfloatnullables_fov_minField of view diameter, min value, max frequency dependentdegphys.angSize;instr.fov;stat.minChar.SpatialAxis.Coverage.Bounds.Extent.LowLimfloatnullables_fov_maxField of view diameter, max value, min frequency dependentdegphys.angSize;instr.fov;stat.maxChar.SpatialAxis.Coverage.Bounds.Extent.HiLimfloatnullables_maximum_angular_scaleMaximum scale in dataset, shortest baseline and frequency dependentarcsecphys.angSize;stat.maxChar.SpatialAxis.Resolution.Scale.Limits.HiLimfloatnullablef_resolutionAbsolute spectral resolution in frequencykHzem.freq;stat.maxChar.SpectralAxis.Coverage.BoundsLimits.HiLimfloatnullablet_exp_minMinimum integration time per samplestime.duration;obs.exposure;stat.minChar.TimeAxis.Sampling.ExtentLoLimfloatnullablet_exp_maxMaximum integration time per samplestime.duration;obs.exposure;stat.maxChar.TimeAxis.Sampling.ExtentHiLimfloatnullablet_exp_meanAverage integration time per samplestime.duration;obs.exposure;stat.meanChar.TimeAxis.Sampling.ExtentHiLimfloatnullableuv_distance_minMinimal distance in uv planemstat.fourier;pos;stat.minChar.UVAxis.Coverage.Bounds.Limits.LoLimfloatnullableuv_distance_maxMaximal distance in uv planemstat.fourier;pos;stat.maxChar.UVAxis.Coverage.Bounds.Limits.LoLimfloatnullableuv_distribution_eccEccentricity of uv distributionstat.fourier;posChar.UVAxis.Coverage.Bounds.Eccentricityfloatnullableuv_distribution_fillFilling factor of uv distributionstat.fourier;pos;arith.ratioChar.UVAxis.Coverage.Bounds.FillingFactorfloatnullableinstrument_ant_numberNumber of antennas in arraymeta.number;instr.paramProvenance.ObsConfig.Instrument.Array.AntNumberfloatnullableinstrument_ant_min_distMinimum distance between antennas in arrayminstr.baseline;stat.minProvenance.ObsConfig.Instrument.Array.MinDistfloatnullableinstrument_ant_max_distMaximum distance between antennas in arrayminstr.baseline;stat.maxProvenance.ObsConfig.Instrument.Array.MaxDistfloatnullableinstrument_ant_diameterDiameter of telecope or antennas in arrayminstr.paramProvenance.ObsConfig.Instrument.Array.Diameterfloatnullableinstrument_feedNumber of feedsinstr.paramProvenance.ObsConfig.Instrument.Feedfloatnullablescan_modeScan mode (on-off, raster map, on-the-fly map,...)instr.paramProvenance.Observation.sky_scan_modefloatnullabletracking_modeTargeted, alt-azimuth, wobble, ...)instr.paramProvenance.Observation.tracking_modefloatnullableivoa.obscoreobs_publisher_didobs_publisher_did
ivoa.obscoreGAVO Data Center Obscore TableThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter.84947229dataproduct_typeHigh level scientific classification of the data product, taken from an enumerationmeta.code.classobscore:obsdataset.dataproducttypecharnullabledataproduct_subtypeData product specific typemeta.code.classobscore:obsdataset.dataproductsubtypecharnullablecalib_levelAmount of data processing that has been applied to the datameta.code;obs.calibobscore:obsdataset.caliblevelshortobs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_resolutionMinimal significant time interval along the time axisstime.resolutionobscore:char.timeaxis.resolution.refval.valuefloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablepol_statesList of polarization states in the data setmeta.code;phys.polarizationobscore:Char.PolarizationAxis.stateListcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullablet_xelNumber of elements (typically pixels) along the time axis.meta.numberobscore:Char.TimeAxis.numBinslongnullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullablepol_xelNumber of elements (typically pixels) along the polarization axis.meta.numberobscore:Char.PolarizationAxis.numBinslongnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullableem_ucdNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)meta.ucdobscore:Char.SpectralAxis.ucdcharnullablepreviewURL of a preview (low-resolution, quick-to-retrieve representation) of the data.meta.ref.url;meta.previewcharnullablesource_tableName of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.meta.id;meta.tablecharnullable
k2c9vstCoordinated microlensing survey observations with Kepler K2/C9 using +VST The Kepler satellite has observed the Galactic center in a campaign +lasting from April until the end of June 2016 (K2/C9). The main +objective of the 99 hours for the microlensing program 097.C-0261(A) +using the ESO VLT Survey Telescope (VST) was to monitor the superstamp +(i.e., the actually downloaded region of K2/C9) in service mode for +improving the event coverage and securing some color-information. Due +to weather conditions, the majority of images were taken in the red +band. These are part of the present release. + +The exact pointing strategy was adjusted to cover the superstamp with +6 pointings and to contain as many microlensing events from earlier +seasons as possible. In addition, a two-point dither was requested to +reduce the impact of bad pixels and detector gaps. Consequently, some +events were getting more coverage and have been observed with +different CCDs. The large footprint of roughly 1 square degree and the +complementary weather conditions at Cerro Paranal have lead to the +coverage of 147 events (this resource's events table), but ~60 of +those were already at baseline.k2c9vst.eventsK2/C9 Microlensing Events The Kepler satellite has observed the Galactic center in a campaign +lasting from April until the end of June 2016 (K2/C9). The main +objective of the 99 hours for the microlensing program 097.C-0261(A) +using the ESO VLT Survey Telescope (VST) was to monitor the superstamp +(i.e., the actually downloaded region of K2/C9) in service mode for +improving the event coverage and securing some color-information. Due +to weather conditions, the majority of images were taken in the red +band. These are part of the present release. + +The exact pointing strategy was adjusted to cover the superstamp with +6 pointings and to contain as many microlensing events from earlier +seasons as possible. In addition, a two-point dither was requested to +reduce the impact of bad pixels and detector gaps. Consequently, some +events were getting more coverage and have been observed with +different CCDs. The large footprint of roughly 1 square degree and the +complementary weather conditions at Cerro Paranal have lead to the +coverage of 147 events (this resource's events table), but ~60 of +those were already at baseline.725event_idEvent name as specified by OGLE (http://ogle.astrouw.edu.pl/ogle4/ews/2015/ews.html) or MOA (http://www.phys.canterbury.ac.nz/moa/). Some event ids actually reference the same object. These have otherwise identical records.meta.id;meta.maincharindexedprimaryraj2000Right ascension of the event source as reported by the OGLE or MOAdegpos.eq.ra;meta.maindoublenullabledej2000Right ascension of the event source as reported by the OGLE or MOAdegpos.eq.dec;meta.maindoublenullablet_alertHJD of alert release.dtime.releasedoublenullablet_0Time of largest magnification estimated from a fit assuming a gravitational lens event of pointlike source and lens.dtime.duration;stat.fitdoublenullablet_eEvent timescale (Einstein time assuming a gravitational lens event of pointlike source and lens).dtime.durationdoublenullableu_0Impact parameter in units of Einstein radii.src.impactParamfloatnullablea_0Maximum magnification.phot.flux;arith.ratiofloatnullableflagsBitmask for flags: bit 0 -- during campaign; bit 1: In footprint (i.e., Kepler data could be available); bit 2: In superstamp (i.e., Kepler data available).meta.codeshort
k2c9vst.photpointsPhotometric Points Obtained by K2/C9 followup The Kepler satellite has observed the Galactic center in a campaign +lasting from April until the end of June 2016 (K2/C9). The main +objective of the 99 hours for the microlensing program 097.C-0261(A) +using the ESO VLT Survey Telescope (VST) was to monitor the superstamp +(i.e., the actually downloaded region of K2/C9) in service mode for +improving the event coverage and securing some color-information. Due +to weather conditions, the majority of images were taken in the red +band. These are part of the present release. + +The exact pointing strategy was adjusted to cover the superstamp with +6 pointings and to contain as many microlensing events from earlier +seasons as possible. In addition, a two-point dither was requested to +reduce the impact of bad pixels and detector gaps. Consequently, some +events were getting more coverage and have been observed with +different CCDs. The large footprint of roughly 1 square degree and the +complementary weather conditions at Cerro Paranal have lead to the +coverage of 147 events (this resource's events table), but ~60 of +those were already at baseline.9384accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullabledidLocal dataset identifier for the lightcurve this point belongs to.meta.id;meta.maincharindexednullableevent_idAssociated Eventcharnullableobs_timeTime this photometry corresponds to.dtime.epochdoublenullablephotSDSS r-band instrumental magnitude (warning: zeropoint may be off several mag).magphot.mag;em.opt.RdoublenullableimageVST image this point was taken from. The raw images are available at http://archive.eso.org/wdb/wdb/eso/eso_archive_main/query?prog_id=097.C-0261(A)meta.ref;meta.filecharnullabledfDifference flux as defined by 2008MNRAS.386L..77Baduphot.fluxdoublenullablee_dfError in difference flux.adustat.error;phot.fluxfloatnullablerfReference flux as defined by 2008MNRAS.386L..77Baduphot.fluxdoublenullablee_rfError in reference Fluxadustat.error;phot.fluxfloatnullablee_photError in SDSS r-band instrumental magnitude.magstat.error;phot.magfloatnullableexp_timeExposure time.stime.duration;obs.exposurefloatnullablefwhmFWHM of the point spread function averaged over all stars on the subimage used.arcsecphys.angSize;instr.det.psffloatnullablesky_backgroundMedian sky background flux.aduinstr.backgroundfloatnullablephot_scale_factorScale factor according to 2008MNRAS.386L..77B; if small, photometry was obtained under suboptimal atmospheric transparency.floatnullablechi2_pxSee 2008MNRAS.386L..77B, sect. 2.1stat.fit.chi2floatnullabledxPixel offset of frame wrt. the reference frame, x directionpixelpos.cartesian.x;arith.difffloatnullabledyPixel offset of frame wrt. the reference frame, y directionpixelpos.cartesian.y;arith.difffloatnullablecorr_coeffCoefficients of correction polynomial for frame: TBDfloatnullablek2c9vst.eventsevent_idevent_id
k2c9vst.timeseries The Kepler satellite has observed the Galactic center in a campaign +lasting from April until the end of June 2016 (K2/C9). The main +objective of the 99 hours for the microlensing program 097.C-0261(A) +using the ESO VLT Survey Telescope (VST) was to monitor the superstamp +(i.e., the actually downloaded region of K2/C9) in service mode for +improving the event coverage and securing some color-information. Due +to weather conditions, the majority of images were taken in the red +band. These are part of the present release. + +The exact pointing strategy was adjusted to cover the superstamp with +6 pointings and to contain as many microlensing events from earlier +seasons as possible. In addition, a two-point dither was requested to +reduce the impact of bad pixels and detector gaps. Consequently, some +events were getting more coverage and have been observed with +different CCDs. The large footprint of roughly 1 square degree and the +complementary weather conditions at Cerro Paranal have lead to the +coverage of 147 events (this resource's events table), but ~60 of +those were already at baseline.119accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxadustat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxadustat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablet_min_mjd(Approximate) earliest timestamp in dataset.dtime.start;obsts:time.startdoubleindexednullablet_max_mjd(Approximate) latest timestamp in dataset.dtime.end;obsts:time.enddoubleindexednullablet_0Time of largest magnification estimated from a fit assuming a gravitational lens event of pointlike source and lens.dtime.duration;stat.fitdoublenullable
kapteynPotsdam Kapteyn Series Plates +In the context of Kapteyn's plan to obtain a photometric standard, in +Potsdam more than 400 photographic plates of several Selected Areas, +Special Areas, and Kapteyn-Pritchard areas were obtained between 1910 and +1933, both as direct images and with an object prism. This service +provides FITS images of the science area of the plates as well as images of +the entire plates, including previous markings.kapteyn.plates +In the context of Kapteyn's plan to obtain a photometric standard, in +Potsdam more than 400 photographic plates of several Selected Areas, +Special Areas, and Kapteyn-Pritchard areas were obtained between 1910 and +1933, both as direct images and with an object prism. This service +provides FITS images of the science area of the plates as well as images of +the entire plates, including previous markings.374accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableexposureEffective exposure time.stime.duration;obs.exposurefloatnullableairmassAirmass at mean epoch.obs.airMassfloatnullableobjectSpecial object on plate.meta.idcharnullableobserverObserver.obs.observercharnullablestart_timeUT at start of exposure.dtime.start;obscharnullableend_timeUT at end of exposure.dtime.end;obscharnullablewfpdb_idPlate identifier as in the WFPDB.meta.idcharnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharnullableplatephotoImage of the plate including border and other markings.meta.ref.urlcharnullable
katkatARI Catalog of Catalogs +ARI katkat is a catalog of star catalogues +in the spirit of G. Teleki's catalog of star catalogs +(`1989BOBeo.140..131T`_ and references in there). It contains +2573 catalogs suitable for astrometric usage, starting with Flamsteed +(1835) and ending in the 1970ies. For almost all of them, there +is a column description file (as PDF, and unfortunately sometimes in +German) and the digitized content. + +.. _1989BOBeo.140..131T: http://ads.g-vo.org/abs/1989BOBeo.140..131Tkatkat.katkatThe "catalog of catalogs" lists catalogs containing stellar positions +for the last centuries. It also lets you access digitized table +data.2573fileidARI-internal file identifiermeta.id;meta.maincharindexedprimarykkidARIGFH identifier of the tablemeta.idcharnullabletelekiTeleki number of the catalogmeta.idintnullablehdwlHDWL number of the catalogmeta.idcharnullablenrowsNumber of rows (i.e., lines) in the catalogmeta.numberintnullablenidNumber of objects that could be matched with the ARIGFH mastermeta.numberintnullablesourceBibliographical information for the catalog.meta.refcharindexednullableremarksRemarks, e.g., on the identification process or where to find media (typically not interesting outside ARI).meta.notecharnullableminepochEarliest epoch of observation (approximate)yrtime.epoch;stat.minfloatnullablemaxepochLatest epoch of observation (approximate)yrtime.epoch;stat.maxfloatnullablekatdataRelative path to the data file (see table description to obtain the data if this is not a complete URLcharnullablekatfieldsURL of a PDF containing the field description (see table description to obtain the data if this is not a complete URLcharnullableliesfPainful FORTRAN used to parse the raw textcharnullable
lamost5LAMOST DR5 survey spectra +This services provides 1D spectra from DR5 of LAMOST (Large Sky Area +Multi-Object Fiber Spectroscopic Telescope) through SSAP and Obscore; +data is served both in VO-standard SDM and, via datalink, the original +SDSS-inspired FITS described in +http://dr5.lamost.org/doc/data-production-description .lamost5.data +This services provides 1D spectra from DR5 of LAMOST (Large Sky Area +Multi-Object Fiber Spectroscopic Telescope) through SSAP and Obscore; +data is served both in VO-standard SDM and, via datalink, the original +SDSS-inspired FITS described in +http://dr5.lamost.org/doc/data-production-description .9100000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullableraj2000Observed RA of the objectdegpos.eq.ra;meta.maindoublenullabledej2000Main value of declinationdegpos.eq.dec;meta.maindoublenullablessa_targsubclassObject subclasscharnullable
lamost6LAMOST DR6 Spectra LAMOST, the The Large Sky Area Multi-Object Fiber Spectroscopic +Telescope (or Guoshoujing Telescope) is an instrument tailored for +producing large number of optical medium- and low-resolution spectra. +Here, we publish both the medium (MRS) and low (LRS) resolution +spectra from Data Release 6, http://dr6.lamost.org/v2/, to the Virtual +Observatory.lamost6.ssa_mrsSSA-compliant metadata for LAMOST DR6 medium resolution spectra; this +data is also availble through Obscore; the collection name there is +LAMOST6 MRS.5900000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.ResolutionfloatnullablemobsidUnique identifier for the medium resolution spectrum (most of these have multiple observations and include a coadded spectrum).meta.id;meta.maincharssa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablerv_b0Radial velocity estimated from the B spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_b0_errError in rv_b0.km/sstat.error;spect.dopplerVelocfloatnullablerv_r0Radial velocity estimated from the R spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_r0_errError in rv_r0.km/sstat.error;spect.dopplerVelocfloatnullablerv_br0Radial velocity estimated from the B and R spectra after continuum removal.km/sspect.dopplerVelocfloatnullablerv_br0_errError in rv_br0.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp0Radial velocity estimated from the LAMOST stellar parameter pipeline.km/sspect.dopplerVelocfloatnullablerv_lasp0_errError in rv_lasp0.km/sstat.error;spect.dopplerVelocfloatnullablerv_b1rv_b0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_b1_errError in rv_b1.km/sstat.error;spect.dopplerVelocfloatnullablerv_r1rv_r0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_r1_errError in rv_r1.km/sstat.error;spect.dopplerVelocfloatnullablerv_br1rv_br0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_br1_errError in rv_br1.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp1rv_lasp0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_lasp1_errError in rv_lasp1.km/sstat.error;spect.dopplerVelocfloatnullablerv_b_flagFlag for RV extraction in the b band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_r_flagFlag for RV extraction in the r band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_br_flagFlag for RV extraction in the br band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortcoadd1 if this is a co-added spectrummeta.codeshortfibermaskBitmask for fiber problems. See note for the meaning for the bits.meta.code.qualshortbad_b1 if this is a problematic B spectrum.meta.codeshortbad_r1 if this is a problematic R spectrum.meta.codeshort
lamost6.ssa_lrsSSA-compliant metadata for LAMOST DR6 low resolution spectra; this +data is also availble through Obscore; the collection name there is +LAMOST6 LRS.10000000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift as estimated by the LAMOST pipeline.src.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablez_errError in ssa_redshift as estimated by the LAMOST pipeline.stat.error;src.redshiftfloatnullable
life_tdThe LIFE Target Star Database LIFETD +The LIFE Target Star Database contains information useful +for the planned `LIFE mission`_ (mid-ir, nulling +interferometer in space). It characterizes possible +target systems including information about stellar, +planetary and disk properties. The data itself is mainly +a collection from different other catalogs. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. + + +.. _LIFE mission: https://life-space-mission.com/life_td.sourceSource Table A list of all the sources for the parameters in the other tables. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +281source_idSource identifier.meta.idintindexedprimaryrefReference, bibcode if possible.meta.refcharnullableprovider_nameName for the service through which the data was acquired. SIMBAD: service = http://simbad.u-strasbg.fr:80/simbad/sim-tap, bibcode = 2000A&AS..143....9W. ExoMercat: service = http://archives.ia2.inaf.it/vo/tap/projects, bibcode = 2020A&C....3100370A. Everything else is acquired through private communication.meta.bib.authorchar
life_td.objectObject table A list of the astrophysical objects. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +3672object_idObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarytypeObject type (sy=multi-object system, st=star, pl=planet and di=disk).src.classcharnullablemain_idMain object identifier.meta.idcharidsAll identifiers of the object separated by '|'.meta.idchar
life_td.providerProvider Table A list of all the providers for the parameters in the other tables. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +provider_nameName for the service through which the data was acquired.meta.bib.authorcharindexedprimaryprovider_urlService through which the data was acquired.meta.ref.urlcharnullableprovider_bibcodeReference, bibcode if possible.meta.refcharnullableprovider_accessDate of access to provider.timecharnullable
life_td.star_basicBasic stellar parameters A list of all basic stellar parameters. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +3137object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarycoo_raRight Ascensiondegpos.eq.ra;meta.maindoubleindexednullablecoo_decDeclinationdegpos.eq.dec;meta.maindoubleindexednullablecoo_err_angleCoordinate error angledegpos.posAng;pos.errorEllipse;pos.eqshortnullablecoo_err_majCoordinate error major axismasphys.angSize.smajAxis;pos.errorEllipse;pos.eqfloatnullablecoo_err_minCoordinate error minor axismasphys.angSize.sminAxis;pos.errorEllipse;pos.eqfloatnullablecoo_qualCoordinate quality (A:best, E:worst)meta.code.qual;pos.eqcharnullablecoo_source_idrefSource identifier corresponding to the position (coo) parameters.meta.refintnullablecoo_gal_lGalactical longitude.degpos.galactic.londoublenullablecoo_gal_bGalactical latitude.degpos.galactic.latdoublenullablecoo_gal_source_idrefSource identifier corresponding to the position (coo_gal) parameters.meta.refintnullablemag_i_valueMagnitude in I filter.phot.mag;em.opt.Idoublenullablemag_i_source_idrefSource identifier corresponding to the Magnitude in I filter parameters.meta.refintnullablemag_j_valueMagnitude in J filter.phot.mag;em.IR.Jdoublenullablemag_j_source_idrefSource identifier corresponding to the Magnitude in J filter parameters.meta.refintnullablemag_k_valueMagnitude in K filter.phot.mag;em.IR.Kdoublenullablemag_k_source_idrefSource identifier corresponding to the Magnitude in K filter parameters.meta.refintnullableplx_valueParallax value.maspos.parallaxdoublenullableplx_errParallax uncertainty.masstat.error;pos.parallaxdoublenullableplx_qualParallax quality (A:best, E:worst)meta.code.qual;pos.parallaxcharnullableplx_source_idrefSource identifier corresponding to the parallax parameters.meta.refintnullabledist_st_valueObject distance.pcpos.distancedoublenullabledist_st_errObject distance error.pcstat.error;pos.distancedoublenullabledist_st_qualDistance quality (A:best, E:worst)meta.code.qual;pos.distancecharnullabledist_st_source_idrefIdentifier of the source of the distance parameter.meta.refintnullablesptype_stringObject spectral type MK.src.spTypecharnullablesptype_errObject spectral type MK error.stat.error;src.spTypedoublenullablesptype_qualSpectral type MK quality (A:best, E:worst)meta.code.qual;src.spTypecharnullablesptype_source_idrefIdentifier of the source of the spectral type MK parameter.meta.ref;src.spTypeintnullableclass_tempObject spectral type MK temperature class.src.spTypecharnullableclass_temp_nrObject spectral type MK temperature class number.src.spTypecharnullableclass_lumObject spectral type MK luminosity class.src.spTypecharnullableclass_source_idrefIdentifier of the source of the spectral type MK classification parameter.meta.ref;src.spTypeintnullableteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintnullableradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintnullablemass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintnullablebinary_flagBinary flag.meta.code.multipcharnullablebinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintnullablesep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
life_td.planet_basicBasic planetary parameters A list of all basic planetary parameters. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +502object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.disk_basicBasic disk parameters A list of all basic disk parameters. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +33object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryrad_valueBlack body radius.AUphys.size.radiusdoublenullablerad_errRadius errorAUstat.error;phys.size.radiusdoublenullablerad_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullablerad_relRadius relation defining upper / lower limit or exact measurement through '<' ,'>', and '='.phys.size.radius;arith.ratiocharnullablerad_source_idrefIdentifier of the source of the disk parameters.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.h_linkObject relation table This table links subordinate objects (e.g. a planets of a star, or a +star in a multiple star system) to their parent objects. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +846parent_object_idrefObject key (unstable, use only for joining to the other tables).meta.id.parent;meta.mainintindexedprimarychild_object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimarymembershipMembership probability.meta.recordintnullableh_link_source_idrefIdentifier of the source of the relationship parameters.meta.refintindexedprimary
life_td.identObject identifiers table A list of the object identifiers. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +63295object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimaryidObject identifier.meta.idcharindexedprimaryid_source_idrefIdentifier of the source of the identifier parameter.meta.refintindexedprimary
life_td.mes_mass_plMass measurement table A list of the planetary mass measurements. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_teff_stEffective temperature measurement table A list of the stellar effective temperature measurements. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_radius_stRadius measurement table A list of the stellar radius measurements. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_mass_stMass measurement table A list of the stellar mass measurements. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_binaryMultiplicitz measurement table A list of the stellar multiplicitz measurements. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarybinary_flagBinary flag.meta.code.multipcharindexedprimarybinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_sep_angPhys. separation measurement table A list of the stellar phys. separation measurements. + +Note that LIFE's target database is living +data. The content – and to some extent even structure – of these +tables may change at any time without prior warning. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintsep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
lightmeterLightmeter Data We give continuous night and day light measurements at all natural +outdoor light levels by a network of low-cost lightmeters. Developed +to start simple, global continuous high cadence monitoring of night +sky brightness and artificial night sky brightening (light pollution) +in 2009. The lightmeter network is a project of the Thüringer +Landessternwarte, Tautenburg, Germany and the Kuffner-Sternwarte +society at the Kuffner-Observatory, Vienna, Austria. + +It started as part of the Dark Skies Awareness cornerstone of the +International Year of Astronomy.lightmeter.stationsStations in the lightmeter network44stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedprimarylatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullableheightHeight above sea levelmpos.earth.altitudefloatnullablefullnameFull name of the stationmeta.idchardevtypeDevice type (as in: IYA Lightmeter, SQM, ...)meta.code;instrcharnullabletimecorrectionSeconds to add to this stations reported times to obtain UTCintnullablecalibaCalibration parameter, ainstr.calibfloatnullablecalibbCalibration parameter, binstr.calibfloatnullablecalibcCalibration parameter, cW.m**-2instr.calibfloatnullablecalibdCalibration parameter, dK**-1instr.calibfloatnullable
lightmeter.measurementsTime-averaged lightmeter measurements3400000stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedepochJD of measurement, UTCdtime.epochdoubleindexedfluxCalibrated fluxW.m**-2phot.fluxfloats_fluxStandard deviation of light measurements contributing to this averageW.m**-2stat.stdev;phot.fluxfloatnullablenvalsNumber of measurements contributing to this valuemeta.number;obsintsourceSource file keymeta.id;meta.filecharnullable
lightmeter.geocountsLightmeter data by date and geographic positionepochJD of measurement, UTCdtime.epochdoublestationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharlatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullablefluxCalibrated fluxW.m**-2phot.fluxfloat
liverpoolLiverpool Quasar Lens MonitoringThis collection includes optical monitorings of gravitationally lensed +quasars. The frames can be used to make light curves of quasar images +and field objects. From quasar light curves, one may measure time +delays and flux ratios, analyse variability and chromaticity, etc. +These direct analyses/measurements are basic tools for different +astrophysical studies, e.g., expansion rate of the Universe, mechanism +of intrinsic variability in quasars, accretion disk structure, +supermassive black holes, dark halos of galaxies (dust, collapsed dark +matter, smoothly distributed dark matter,...)liverpool.rawframesThis collection includes optical monitorings of gravitationally lensed +quasars. The frames can be used to make light curves of quasar images +and field objects. From quasar light curves, one may measure time +delays and flux ratios, analyse variability and chromaticity, etc. +These direct analyses/measurements are basic tools for different +astrophysical studies, e.g., expansion rate of the Universe, mechanism +of intrinsic variability in quasars, accretion disk structure, +supermassive black holes, dark halos of galaxies (dust, collapsed dark +matter, smoothly distributed dark matter,...)561accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablecreation_dateDate of FITS file creationdtime.creationcharnullabletypeType of the observation (Science, Flat...)meta.code.classcharobjectObject observed, Simbad resolvable identifiermeta.idcharnullableraw_objectObject observed as given in the headermeta.idcharnullableobservatoryObservatory of origin for this framemeta.id;instr.obstycharnullabletelescopeTelescope used to obtain the frameinstr.telcharnullableinstrumentIdentifier of the originating instrumentcharnullabledetectorDetector usedmeta.id;instrcharnullableexposureExposure timestime.duration;obs.exposurefloatnullableairmassAir mass at center of observationobs.airMassfloatnullablemoonfracFraction of illuminated area of the moon at obs. timeobs.param;arith.ratiofloatnullablemoondistLunar distance from targetdegpos.angDistancefloatnullablel1satIs the brightest object in the field saturated?instr.saturation;stat.maxbooleanbackgroundBackground in countsct.s**-1instr.backgroundfloatnullableseeingEstimate for seeing at observation timearcsecinstr.obsty.seeingfloatnullablestarttimeUT at start of observationtime.startcharnullable
lotsspol Rotation Measures from the LOFAR Two Meter Sky Survey LoTSS DR2 +The LOFAR Two Meter Sky Survey LoTSS DR2 +(:bibcode:`2022A&A...659A...1S`) obtained radio data from 27% of the +northern sky between 120 and 168 MHz in the year 2014 through 2020. This +service publishes polarization spectra of extragalactic radio sources +(radio galaxies and blazars) and the rotation measures derived from them. +We also give redshifts for all sources. The data has a spatial resolution +of 20 arcsec.lotsspol.rmtableA table of rotation measures derived +from the content of lotsspol.spectra. This is supposed to be in line with +RMTable version 1, https://github.com/CIRADA-Tools/RMTable.2461cat_idSource ID in catalogmeta.id;meta.mainshortraRight Ascension [ICRS] of the polarised emission at epoch (this will often be an one extremity of the radio source).degpos.eq.ra;meta.maindoublenullabledecDeclination [ICRS] of the polarised emission at epoch (this will often be an one extremity of the radio source).degpos.eq.dec;meta.maindoublenullabledatalinkDatalink for the spectrummeta.ref.urlcharnullablermRotation measurerad.m**-2phys.polarization.rotMeasure;meta.mainfloatnullablerm_errTotal error in RMrad.m**-2stat.error;phys.polarization.rotMeasuredoublenullablerm_err_snrError in RM from signal to noise ratio onlyrad.m**-2stat.error;phys.polarization.rotMeasuredoublenullablepolintPolarized intensityJyphot.flux.density;phys.polarization.lineardoublenullablepolint_errError in Polarised IntensityJystat.error;phot.flux.density;phys.polarization.linearfloatnullablefracpolFractional (linear) polarizationphys.polarization.lineardoublenullablefracpol_errError in fractional polarizationstat.error;phys.polarization.linearfloatnullablermsf_fwhmFull-width at half maximum of the RMSFrad.m**-2instr.rmsf;stat.fwhmfloatnullablereffreq_polReference frequency for polarizationHzem.freq;phys.polarizationfloatnullablelGalactic Longitudedegpos.galactic.londoublenullablebGalactic Latitudedegpos.galactic.latdoublenullablepos_errPosition uncertaintydegstat.error;posdoublenullablebeamdistDistance from beam centre (taken as centre of tile)degpos.angDistance;instr.beamfloatnullablecatnameName of catalog this was taken from.meta.notecharnullablecomplex_flagFaraday complexity flagmeta.codecharnullablecomplex_testFaraday complexity metricmeta.notecharnullablerm_methodRM determination methodmeta.notecharnullableionosphereIonospheric correction methodmeta.notecharnullablepol_biasPolarization bias correction methodmeta.notecharnullableflux_typeStokes extraction methodmeta.notecharnullablebeam_majBeam major axisdegpos.angResolution;instr.beam;phys.angSize.smajAxisfloatnullablebeam_minBeam minor axisdegpos.angResolution;instr.beam;phys.angSize.sminAxisfloatnullablebeam_paBeam position angledegpos.angResolution;instr.beam;pos.posAngfloatnullablereffreq_beamReference frequency for beamHzem.freq;instr.beamfloatnullableminfreqLowest frequencyHzem.freq;stat.minfloatnullablemaxfreqHighest frequencyHzem.freq;stat.maxfloatnullablechannelwidthTypical channel widthHzem.freq;instr.bandwidthfloatnullablenoise_chanTypical per-channel noise in Q;UJystat.error;instr.det.noisefloatnullabletelescopeName of Telescope(s)instr.telcharnullableint_timeIntegration timestime.duration;obs.exposurefloatnullableepoch_mjdMedian epoch of observationdtime.epochdoublenullableobs_intervalInterval of observationdtime.intervalfloatnullableleakageInstrumental leakage estimatephys.polarization.linearfloatnullabledatarefData referencesmeta.bib.bibcodecharnullablenotesNotesmeta.notecharnullablereffreq_iReference frequency for Stokes IHzem.freq;phys.polarization.stokes.IfloatnullablefieldLoTSS observation pointing namemeta.id;obs.fieldcharnullablexx-pixel coordinate within an individual LoTSS field, ranging from 0 to 3200, for a pixel width of 4.5 arcsecpixelpos.cartesian.x;instr.detshortyy-pixel coordinate within an individual LoTSS field, ranging from 0 to 3200, for a pixel height of 4.5 arcsecpixelpos.cartesian.y;instr.detshortsnr_rmtools_madSignal to noise ratio based the peak polarized intensity divided by the estimated noise in the Faraday depth spectrum (where the noise is computed using the median deviation from the median of the polarized intensity, and then correcting to be equivalent to a Gaussian sigma).stat.snr;phot.flux;phys.polarizationdoublenullablera_nvssRA of the object in NVSSdegpos.eq.radoublenullabledec_nvssDec of the object in NVSSdegpos.eq.decdoublenullablenvss_rmRotation measure of the object in NVSSrad.m**-2phys.polarization.rotMeasurefloatnullablenvss_rm_errError in rotation measure of the object in NVSSrad.m**-2stat.error;phys.polarization.rotMeasurefloatnullablei_nvssIntegrated Stokes I flux density from NVSSmJyphot.flux;phys.polarization.stokes.Ifloatnullablep_nvssAverage peak polarized intensity from NVSSmJyphot.flux;phys.polarization.stokes.Ifloatnullablepi_nvssPercent polarization from NVSSphys.polarization;arith.ratiofloatnullableseparation_nvssDifference between NVSS position and LoTSS DR2 positionarcsecpos.angDistancedoublenullablelgz_sizeLargest angular size of the sourcearcsecphys.angsize;stat.maxdoublenullablezphotPhotometric redshift derived here from archive photometry (WISE, PanSTARRS, etc; cf. 2021A&A...648A...4D).src.redshift.photdoublenullablezphot_errError in zphotstat.error;src.redshift.photdoublenullablephot_spec_z_bestNature of z_best: 0: phot, 1: specmeta.code;src.redshiftshortlgz_ra_degRA of the host galaxy, mainly from NED.degpos.eq.radoublenullablelgz_dec_degDec of the host galaxy, mainly from NED.degpos.eq.decdoublenullablez_bestBest redshift available from the literature, typically from NED.src.redshiftdoublenullablenum_in_fieldNumber of polarized sources in the originating pointing.meta.number;srcshortmedrmMedian RM in the originating pointing.rad.m**-2phys.polarization.rotMeasure;stat.medianfloatnullablemadrmMedian absolute deviation of RM in the originating pointing.rad.m**-2stat.mad;phys.polarization.rotMeasurefloatnullablemedfpolMedian degree of polarization in the originating pointing (percent).phys.polarization;stat.medianfloatnullablemadfpolMedian absolute deviation of degree of polarization in the originating pointing (percent).stat.mad;phys.polarizationfloatnullablera_centreRA of field centredegpos.eq.ra;obs.fielddoublenullabledec_centreDec of field centredegpos.eq.dec;obs.fielddoublenullablenchanNumber of channels used in RM derivationmeta.number;em.binintnullablesource_name_dr2Official source name assigned by the International LOFAR Telescope ILT.meta.idcharnullablera_dr2LoTSS DR2 RA of the centroid of the total radio intensity using pyBDSF.degpos.eq.radoublenullabledec_dr2LoTSS DR2 Dec of the centroid of the total radio intensity using pyBDSF.degpos.eq.decdoublenullablee_ra_dr2Error in ra_dr2degstat.error;pos.eq.radoublenullablee_dec_dr2Error in dec_dr2degstat.error;pos.eq.decdoublenullabletotal_flux_dr2Total radio flux at 144 MHz from pyBDSF.Jyphot.flux;em.radiodoublenullablee_total_flux_dr2Error in total_flux_dr2Jystat.error;phot.flux;em.radiodoublenullablemaj_dr2Semimajor axis of the radio emissionarcsecphys.angSize.smajAxisdoublenullablemin_dr2Semiminor axis of the radio emissionarcsecphys.angSize.sminAxisdoublenullablepa_dr2Position angle of the radio emission, north over westdegpos.posAngdoublenullablel144Spectral luminosity at 144 MHz in the rest frame of the sourceW.Hz**-1phys.luminositydoublenullablelinearsize_kpcProjected largest linear sizekpcphys.sizedoublenullablerrmThe residual RM after subtraction of the average Galactic RM within an aperture of radius 1 degree (see the grm column).rad.m**-2phys.polarization.rotMeasure;src.netdoublenullablegrmAverage Galactic RM within an aperture of radius 1 degree from the Garching Faraday rotation sky v2.rad.m**-2phys.polarization.rotMeasuredoublenullablegrmerrError in grm.rad.m**-2stat.error;phys.polarization.rotMeasuredoublenullablebzcat_nameBlazar source name in the ROMA-BZCAT catalogue (2015Ap&SS.357...75M)meta.id.crosscharnullable
lotsspol.spectraSpectrally resolved polarisation; for pre-derived rotation measures, +see lotsspol.rmtable. The spectral behaviour of the LoTSS Stokes I data +are presently unreliable and not included here. However, one can use +the stokes_i column in lotsspol.rmtable in combination with an assumed +radio spectral index to produce fractional polarization spectra.2461ssa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.ClasscharnullableaccrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablecat_idRunning number of the sourcemeta.id;meta.mainlongfreqThe spectral coordinateHzem.freqdoublenullablestokesiPer-frequency Stokes polarization coefficients ImJy/beamphys.polarization.stokes.Idoublenullablestokesi_errorError in stokesimJy/beamstat.error;phys.polarization.stokes.IdoublenullablestokesqPer-frequency Stokes polarization coefficients QmJy/beamphys.polarization.stokes.Qdoublenullablestokesq_errorError in stokesqmJy/beamstat.error;phys.polarization.stokes.QdoublenullablestokesuPer-frequency Stokes polarization coefficients UmJy/beamphys.polarization.stokes.Udoublenullablestokesu_errorError in stokesumJy/beamstat.error;phys.polarization.stokes.Udoublenullablegalactic_locationssa_location expressed in galactic coordinates (do not use for querying: there's no index on this).pos;pos.galacticdoublenullable
lotsspol.ssameta +The LOFAR Two Meter Sky Survey LoTSS DR2 +(:bibcode:`2022A&A...659A...1S`) obtained radio data from 27% of the +northern sky between 120 and 168 MHz in the year 2014 through 2020. This +service publishes polarization spectra of extragalactic radio sources +(radio galaxies and blazars) and the rotation measures derived from them. +We also give redshifts for all sources. The data has a spatial resolution +of 20 arcsec.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullable
lspmThe Lepine-Shara Catalog of High Proper Motion Stars The LSPM catalog is a comprehensive list of 61,977 stars north of the +J2000 celestial equator that have proper motions larger than 0.15"/yr +(local-background-stars frame). + +Positions are given with an accuracy of <~100 mas at the 2000.0 epoch, +and absolute proper motions are given with an accuracy of ~8 mas/yr. +The catalog is estimated to be over 99% complete at high Galactic +latitudes (|b|>15{deg}) and over 90% complete at low Galactic +latitudes (|b|>15{deg}), down to a magnitude.lspm.main The LSPM catalog is a comprehensive list of 61,977 stars north of the +J2000 celestial equator that have proper motions larger than 0.15"/yr +(local-background-stars frame). + +Positions are given with an accuracy of <~100 mas at the 2000.0 epoch, +and absolute proper motions are given with an accuracy of ~8 mas/yr. +The catalog is estimated to be over 99% complete at high Galactic +latitudes (|b|>15{deg}) and over 90% complete at low Galactic +latitudes (|b|>15{deg}), down to a magnitude.61977idLSPM star namemeta.id;meta.maincharnullableraj2000Right Ascension (J2000, Ep=J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000, Ep=J2000)degpos.eq.dec;meta.maindoubleindexednullablepmTotal Proper Motiondeg/yrpos.pmfloatnullablepmraProper Motion in Right Ascensiondeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper Motion in Declinationdeg/yrpos.pm;pos.eq.rafloatnullableaflagAstrometry sourcemeta.refcharnullablebmagOptical B magnitudemagphot.mag;em.opt.BfloatnullablevmagOptical V magnitudemagphot.mag;em.opt.VfloatnullablebjmagPhotographic Blue (IIIaJ) magnitudemagphot.mag;em.opt.BfloatnullablerfmagPhotographic Red (IIIaF) magnitudemagphot.mag;em.opt.RfloatnullableinmagPhotographic Infrared (IVN) magnitudemagphot.mag;em.opt.Rfloatnullablejmag2MASS J magnitudemagphot.mag;em.ir.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.ir.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.ir.Kfloatnullablevmag_eEstimated V magmagphot.mag;em.opt.Vfloatnullable
lswHDAP -- Heidelberg Digitized Astronomical PlatesScans of plates kept at Landessternwarte Heidelberg-Königstuhl. They +were obtained at location, at the German-Spanish Astronomical Center +(Calar Alto Observatory), Spain, and at La Silla, Chile. The plates +cover a time span between 1880 and 1999. + +Specifically, HDAP is essentially complete for the plates taken with +the Bruce telescope, the Walz reflector, and Wolf's Doppelastrograph +at both the original location in Heidelberg and its later home on +Königstuhl.lsw.plates The main catalog of the plates contained in the archive.19603accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableexposureEffective exposure timestime.duration;obs.exposurefloatnullableairmassAirmass at mean epochobs.airMassfloatnullableobjectSpecial object on platemeta.idcharnullableemulsionEmulsion of the original plateinstr.plate.emulsioncharnullablefilterFilter descriptionmeta.id;instr.filter;meta.maincharnullableobserverObserverobs.observercharnullablestarttimeUT at start of exposuredtime.start;obscharnullableendtimeUT at end of exposuredtime.end;obscharnullableplateidPlate name as specified in observation cataloguecharindexednullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharnullable
lsw.wolfpalisa A mapping between HDAP plate identifiers and Wolf-Palisa survey plate +numbers.210w_p_idPlate number in the Wolf-Palisa surveymeta.idcharnullableplateidPlate name as specified in observation cataloguecharnullable
magicMAGIC Public Spectra The MAGIC project observes the VHE sky (GeV~TeV) through Cherenkov +radiation events. The project is operating since 2004 and with the +support from the Spain-VO team they provide data access through a +VO-SSAP and web services. This service re-publishes the data with +homogeneized in flux units (given here in 'erg/(s.cm2)'). Photon +energy values in are transfomred to frequencies.magic.main The MAGIC project observes the VHE sky (GeV~TeV) through Cherenkov +radiation events. The project is operating since 2004 and with the +support from the Spain-VO team they provide data access through a +VO-SSAP and web services. This service re-publishes the data with +homogeneized in flux units (given here in 'erg/(s.cm2)'). Photon +energy values in are transfomred to frequencies.95accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_referencecharnullablereference_doicharnullableebl_correctedshortra_j2000Right Ascensiondegpos.eq.radoubledec_j2000Declinationdegpos.eq.decdouble
maidanakMaidanak Observatory Lens ImagesObservations of (mainly) lensed quasars from Maidanak Observatory, +Uzbekhistanmaidanak.reduced Reduced frames of lensed quasar observations from Maidanak +Observatory. See the referenceURL for details on the reduction +procedure and calibration data.accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefilenameFile name as supplied by the observatory -- unreliablemeta.idchartypeType of observation (science, flat, bias, calib...)meta.code.classcharobjectObject being observed, Simbad-resolvable formmeta.id;meta.maincharnullableraw_objectTarget object as supplied by the observatorymeta.idcharnullableobservatoryObservatory the image was obtained atmeta.id;instr.obstycharnullabletelescopeTelescope used to obtain the imageinstr.telcharnullableinstrumentIdentifier of the detecting instrumentinstr.setupcharnullabledetectorInternal detector IDmeta.id;instr.detcharnullableexposureExposure timestime.duration;obs.exposurefloatnullablestarttimeStart of exposure in UTtime.startcharnullableendtimeEnd of exposure in UTtime.endcharnullablechipidDetector Chipmeta.id;instr.detcharnullablep_dewarDewar Pressure (unreliable)phys.pressure;instr.paramfloatnullableari_rawRaw object name assigned at ARImeta.idcharnullablepub_didPublisher dataset Identifiermeta.ref.ivoidcharnullable
mcextinctReddening and Extinction maps of the Magellanic Clouds A catalogue of E(V-I) extinction values is presented for 3174 (LMC) +and 693 (SMC) fields within the Magellanic Clouds. The extinction +values were computed by determining the (V-I) colour difference of the +red clump from Optical Gravitational Microlensing Experiment (OGLE +III) observations in the V and I bands and theoretical values for +unreddend red clump colours.mcextinct.exts Extinction values within certain areas in the Magellanic clouds.3867bboxBounding box for the extinction datapos.outline;obs.fielddoublenullablecenteralphaArea center RA ICRSdegpos.eq.ra;meta.mainfloatindexednullablecenterdeltaArea center Declination ICRSdegpos.eq.dec;meta.mainfloatindexednullableev_iReddening (color difference between observation and theory, V-I)magphot.color.excess;em.opt.V;em.opt.Ifloatnullablesig_ev_iDifferential reddening calculated as FWHM of the red clump star distributionmagstat.stdev;phot.color.excessfloatnullable
mlqsoSpectra of Strongly Lensed Quasars +An archive of optical and near-infrared spectra of strongly lensed +quasars and the lensing galaxies. The spectra are resolved to about a +few Ångstroms and are flux-calibrated. The spectra resulted from +deblending the lensed images in bidimensional spectra available from +the SSAP service for `ivo://org.gavo.dc/mlqso/q/s +<http://dc.zah.uni-heidelberg.de/mlqso/q/s/info>`_.mlqso.slitspectra Bidimensional spectra of galaxies lensing QSOs.832accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.LengthintnullableremarkRemarks on the data set by the data creator.meta.notecharnullable
mlqso.cubes Bidirectional spectra as FITS image.12accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullabledatalinkDatalinks (related data, cutouts, etc) for this datasetmeta.ref.urlcharnullable
mpcMinor Planet Center - Asteroid Orbital Data +Complete Asteroid Data from the Minor Planet Center (MPC), +updated once per month. The MPC operates at the Smithsonian Astrophysical +Observatory under the auspices of Division III of the International +Astronomical Union (IAU). + +The MPC Orbit database contains orbital elements of minor +planets that have been published in the Minor Planet Circulars, +the Minor Planet Orbit Supplement and the Minor Planet +Electronic Circulars.mpc.mpcorb +Complete Asteroid Data from the Minor Planet Center (MPC), +updated once per month. The MPC operates at the Smithsonian Astrophysical +Observatory under the auspices of Division III of the International +Astronomical Union (IAU). + +The MPC Orbit database contains orbital elements of minor +planets that have been published in the Minor Planet Circulars, +the Minor Planet Orbit Supplement and the Minor Planet +Electronic Circulars.1200000designationAsteroid number or provisional designation.meta.id;meta.maincharnullablemagAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatindexednullableslopeSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemimaj_axOrbital semimajor axisAUphys.size.smajAxisfloatindexednullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablenameHuman-readable designation of the Asteroid.meta.idunicodeCharindexednullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mpc.epn_core EPN-TAP table for MPC Asteroid Orbital Data The EPN-TAP 2.0 version of the complete asteroid data from the Minor +Planet Center (MPC), updated once per month. The MPC operates at the +Smithsonian Astrophysical Observatory under the auspices of Division +III of the International Astronomical Union (IAU). + +The MPC Orbit database contains orbital elements of minor planets that +have been published in the Minor Planet Circulars, the Minor Planet +Orbit Supplement and the Minor Planet Electronic Circulars.ivo://ivoa.net/std/epntap#table-2.0granule_uidInternal table row index, which must be unique within the table. Can be alphanumeric.meta.idchargranule_gidCommon to granules of same type (e.g. same map projection, or geometry data products). Can be alphanumeric.meta.idcharobs_idAssociates granules derived from the same data (e.g. various representations/processing levels). Can be alphanumeric, may be the ID of original observation.meta.id;obschardataproduct_typeThe high-level organization of the data product, from a controlled vocabulary (e.g., 'im' for image, sp for spectrum). Multiple terms may be used, separated by # characters.meta.code.classcharnullabletarget_nameStandard IAU name of target (from a list related to target class), case sensitivemeta.id;srcunicodeCharnullabletarget_classType of target, from a controlled vocabulary.src.classcharnullabletime_minAcquisition start time (in JD), as UTC at time_refpositiondtime.start;obsdoublenullabletime_maxAcquisition stop time (in JD), as UTC at time_refpositiondtime.end;obsdoublenullabletime_sampling_step_minSampling time for measurements of dynamical phenomena, lower limit.stime.resolution;stat.mindoublenullabletime_sampling_step_maxSampling time for measurements of dynamical phenomena, upper limitstime.resolution;stat.maxdoublenullabletime_exp_minIntegration time of the measurement, lower limit.stime.duration;obs.exposure;stat.mindoublenullabletime_exp_maxIntegration time of the measurement, upper limitstime.duration;obs.exposure;stat.maxdoublenullablespectral_range_minSpectral range (frequency), lower limit.Hzem.freq;stat.mindoublenullablespectral_range_maxSpectral range (frequency), upper limitHzem.freq;stat.maxdoublenullablespectral_sampling_step_minSpectral sampling step, lower limit.Hzem.freq;spect.binSize;stat.mindoublenullablespectral_sampling_step_maxSpectral sampling step, upper limitHzem.freq;spect.binSize;stat.maxdoublenullablespectral_resolution_minSpectral resolution, lower limit.spect.resolution;stat.mindoublenullablespectral_resolution_maxSpectral resolution, upper limitspect.resolution;stat.maxdoublenullablec1minRight Ascension (ICRS), lower limit.degpos.eq.ra;stat.mindoublenullablec1maxRight Ascension (ICRS), upper limitdegpos.eq.ra;stat.maxdoublenullablec2minDeclination (ICRS), lower limit.degpos.eq.dec;stat.mindoublenullablec2maxDeclination (ICRS), upper limitdegpos.eq.dec;stat.maxdoublenullablec3minDistance from coordinate origin, lower limit.AUpos.distance;stat.mindoublenullablec3maxDistance from coordinate origin, upper limitAUpos.distance;stat.maxdoublenullables_regionObsCore-like footprint, valid for celestial, spherical, or body-fixed framespos.outline;obs.fieldcharnullablec1_resol_minResolution in the first coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec1_resol_maxResolution in the first coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec2_resol_minResolution in the second coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec2_resol_maxResolution in the second coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec3_resol_minResolution in the third coordinate, lower limit.AUpos.resolution;stat.mindoublenullablec3_resol_maxResolution in the third coordinate, upper limitAUpos.resolution;stat.maxdoublenullablespatial_frame_typeFlavor of coordinate system, defines the nature of coordinates. From a controlled vocabulary, where 'none' means undefined.meta.code.class;pos.framecharnullableincidence_minIncidence angle (solar zenithal angle) during data acquisition, lower limit.degpos.incidenceAng;stat.mindoublenullableincidence_maxIncidence angle (solar zenithal angle) during data acquisition, upper limitdegpos.incidenceAng;stat.maxdoublenullableemergence_minEmergence angle during data acquisition, lower limit.degpos.emergenceAng;stat.mindoublenullableemergence_maxEmergence angle during data acquisition, upper limitdegpos.emergenceAng;stat.maxdoublenullablephase_minPhase angle during data acquisition, lower limit.degpos.phaseAng;stat.mindoublenullablephase_maxPhase angle during data acquisition, upper limitdegpos.phaseAng;stat.maxdoublenullableinstrument_host_nameStandard name of the observatory or spacecraftmeta.id;instr.obstycharnullableinstrument_nameStandard name of instrumentmeta.id;instrcharnullablemeasurement_typeUCD(s) defining the data, with multiple entries separated by hash (#) characters.meta.ucdcharnullableprocessing_levelDataset-related encoding, or simplified CODMAC calibration levelmeta.calibLevelintcreation_dateDate of first entry of this granuletime.creationcharnullablemodification_dateDate of last modification (used to handle mirroring)time.processingcharnullablerelease_dateStart of public access periodtime.releasecharnullableservice_titleTitle of resource (an acronym really, will be used to handle multiservice results)meta.titlecharnullablealt_target_nameProvides alternative target name if more common (e.g. comets); multiple identifiers can be separated by hashesmeta.id;srcunicodeCharnullablemagnitudeAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatnullableslope_parameterSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemi_major_axisOrbital semimajor axisAUphys.size.smajAxisfloatnullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mwscGlobal Survey of Star Clusters in the Milky Way MWSC presents a list of 3006 Milky Way Stellar Clusters (MWSC), found +in the 2MAst (2MASS with Astrometry) catalogue. The target list was +compiled on the basis of present-day lists of open, globular and +candidate clusters. For confirmed clusters we determined a homogeneous +set of astrophysical parameters such as membership, angular radii of +the main morphological parts, mean cluster proper motions, distances, +reddenings, ages, tidal parameters, and sometimes radial velocities.mwsc.mainA list of milky way stellar cluster candidates and objects, together +with the notes and parameters from confirmed objects for the original +publication.3784recnoMWSC sequential number (cluster catalog number).meta.id;meta.maincharindexedprimarynameNGC, IC or other common designationmeta.idcharnullableconfirmation_flagIs this object a stellar cluster? 'dupe' indicates the object coincides with another cluster.charobject_typeObject typesrc.classcharnullableot_certainTrue if the object type is confirmed, false if object type has candidate status.meta.code;src.classbooleannullablesourceSource for MWSC list and input parametersmeta.refcharnullablesource_typeObject type from sourcesrc.classcharnullablen_starNumber of stars in MWSC sky area.meta.numberintraj2000Adopted cluster centre in RA J2000.0degpos.eq.ra;meta.maindoublenullabledej2000Adopted cluster centre in Dec J2000.0degpos.eq.dec;meta.maindoublenullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablercoreAngular radius of the coredegphys.angSize;srcfloatnullablercenterAngular radius of the central partdegphys.angSize;srcfloatnullablerclusterAngular radius of the clusterdegphys.angSize;srcfloatindexednullablepmraAverage proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.ra;stat.meanfloatnullablepmdeAverage proper motion in Declinationdeg/yrpos.pm;pos.eq.dec;stat.meanfloatnullablee_pmError of proper motiondeg/yrstat.error;pos.pm;pos.eq.ra;stat.meanfloatnullablervAverage radial velocitykm/sspect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablen_rvNumber of stars used for RVkm/smeta.number;spect.dopplerVeloc;pos.heliocentric;stat.meanintnullablen1s_coreNumber of most probable (1sigma) members within R(core)meta.numberintnullablen1s_centerNumber of most probable (1sigma) members within R(center); these are the stars used to compute the average proper motion.meta.numberintnullablen1s_clusterNumber of most probable (1sigma) members within R(cluster)meta.numberintnullabledistDistance from the Sunpcpos.distance;pos.heliocentricfloatindexednullablecol_ex_optColour excess in (B-V)magphot.color.excess;phot.color;em.opt.B;em.opt.Vfloatnullabledist_modApparent distance modulus in Ksmagphot.mag.distModfloatnullablecol_ex_jColour excess in (J-Ks)magphot.color.excess;phot.color;em.ir.J;em.ir.Kfloatnullablecol_ex_hColour excess in (J-H)magphot.color.excess;phot.color;em.ir.J;em.ir.Hfloatnullabledelta_hCorrection to H mag of fitted isochrone, empirically introduced to achieve a better fit in the Ks vs. J-H CMD. (see 2012A&A...543A.156K).magphot.mag;arith.difffloatnullablelogtLogarithm of average agelog(yr)time.age;stat.meanfloatindexednullablee_logtError in logarithm of average agelog(yr)stat.error;time.agefloatnullablentNumber of stars used for log(T) calculationmeta.numberintnullablercKing core radiuspcphys.size.radiusfloatnullablee_rcError of King core radiuspcstat.error;phys.size.radiusfloatnullablertKing tidal radiuspcphys.size.radiusfloatnullablee_rtError of King tidal radiuspcstat.error;phys.size.radiusfloatnullablekingkKing normalization factor (a measure of the central density of the cluster, see 2007A&A...468..151Ppc**-2stat.fit.paramfloatnullablee_kingkError of King normalization factorpc**-2stat.error;stat.fit.paramfloatnullablefe_hMetallicity [Fe/H]; this is copied from 2013arXiv1309.4325C or 2012A&A...539A.125D. Data for globular clusters is taken from the revised Harris (1996) catalogue, edition 2010, or newly determined.phys.abund.Fefloatindexednullablee_fe_hError of Metallicitystat.error;phys.abund.Fefloatnullablen_fe_hNumber of objects in [Fe/H] calculation.meta.numbershortnullablenote_textThe text of the note for an object.meta.notecharnullable
mwsc.starsData on cluster stars.64000000recnoMWSC number of the cluster containing the star.meta.id;meta.maincharindexedraj2000Stellar Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Stellar Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablemagbB magnitude in Johnson system.magphot.mag;em.opt.BfloatnullablemagvV magnitude in Johnson system.magphot.mag;em.opt.VfloatindexednullablemagjMagnitude in the 2MASS J bandmagphot.mag;em.ir.Jfloatindexednullablee_magjError in the magnitude in the 2MASS J bandmagstat.error;phot.mag;em.ir.JfloatnullablemaghMagnitude in the 2MASS H bandmagphot.mag;em.ir.Hfloatnullablee_maghError in the magnitude in the 2MASS H bandmagstat.error;phot.mag;em.ir.HfloatnullablemagksMagnitude in the 2MASS Ks bandmagphot.mag;em.ir.Kfloatnullablee_magksError in the magnitude in the 2MASS Ks bandmagstat.error;phot.mag;em.ir.KfloatnullablepmraStellar proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.rafloatnullablepmdeStellar proper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmError of stellar proper motiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablervStellar radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableqflg2MASS JHK photometric quality flagmeta.code.qual;photcharnullablerflg2MASS photometric read flagmeta.refcharnullablebflg2MASS photometric blend flagmeta.codecharnullabletwomassidUnique identifier in 2MASS (pts_key)meta.id.crossintasccIdentifier in ASCC 2.5meta.id.crossintnullablespectralSpectral type and luminosity classsrc.spTypecharnullabler_clAngular distance from cluster centredegpos.angDistancefloatnullablep_spatProbability of membership from spatial propertiesstat.probabilityfloatindexednullablep_kinProbability of membership from kinetic propertiesstat.probabilityfloatindexednullablep_jksProbability of membership from J, Ks photometrystat.probabilityfloatindexednullablep_jhProbability of membership from J, H photometrystat.probabilityfloatnullablemwsc.mainrecnorecno
mwsce14aGlobal Survey of Star Clusters in the Milky Way. III. 139 new open +clusters at high Galactic latitudes +MWSC-e14a ("MWSC extension 2014a") is a catalogue of +139 new open clusters at high Galactic latitudes +(\|b\|>20 deg) including lists of candidate members. It extends the +Kharchenko et al. 'Catalog of Milky Way Star Clusters'. +The target list was compiled as density enhancements found in the 2MASS +point source catalogue. For confirmed clusters we determined a homogeneous +set of astrophysical parameters such as membership, angular radii of the +main morphological parts, proper motion, distance, reddening, age, and +tidal parameters. + +.. _Catalog of Milky Way Star Clusters: http://dc.g-vo.org/mwsc/q/clu/formmwsce14a.main +MWSC-e14a ("MWSC extension 2014a") is a catalogue of +139 new open clusters at high Galactic latitudes +(\|b\|>20 deg) including lists of candidate members. It extends the +Kharchenko et al. 'Catalog of Milky Way Star Clusters'. +The target list was compiled as density enhancements found in the 2MASS +point source catalogue. For confirmed clusters we determined a homogeneous +set of astrophysical parameters such as membership, angular radii of the +main morphological parts, proper motion, distance, reddening, age, and +tidal parameters. + +.. _Catalog of Milky Way Star Clusters: http://dc.g-vo.org/mwsc/q/clu/form782recnoMWSC sequential number (cluster catalog number).meta.id;meta.maincharindexedprimarynameNGC, IC or other common designationmeta.idcharnullableconfirmation_flagIs this object a stellar cluster? 'dupe' indicates the object coincides with another cluster.charobject_typeObject typesrc.classcharnullableot_certainTrue if the object type is confirmed, false if object type has candidate status.meta.code;src.classbooleannullablesourceSource for MWSC list and input parametersmeta.refcharnullablesource_typeObject type from sourcesrc.classcharnullablen_starNumber of stars in MWSC sky area.meta.numberintraj2000Adopted cluster centre in RA J2000.0degpos.eq.ra;meta.maindoublenullabledej2000Adopted cluster centre in Dec J2000.0degpos.eq.dec;meta.maindoublenullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablercoreAngular radius of the coredegphys.angSize;srcfloatnullablercenterAngular radius of the central partdegphys.angSize;srcfloatnullablerclusterAngular radius of the clusterdegphys.angSize;srcfloatindexednullablepmraAverage proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.ra;stat.meanfloatnullablepmdeAverage proper motion in Declinationdeg/yrpos.pm;pos.eq.dec;stat.meanfloatnullablee_pmError of proper motiondeg/yrstat.error;pos.pm;pos.eq.ra;stat.meanfloatnullablervAverage radial velocitykm/sspect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablen_rvNumber of stars used for RVkm/smeta.number;spect.dopplerVeloc;pos.heliocentric;stat.meanintnullablen1s_coreNumber of most probable (1sigma) members within R(core)meta.numberintnullablen1s_centerNumber of most probable (1sigma) members within R(center); these are the stars used to compute the average proper motion.meta.numberintnullablen1s_clusterNumber of most probable (1sigma) members within R(cluster)meta.numberintnullabledistDistance from the Sunpcpos.distance;pos.heliocentricfloatindexednullablecol_ex_optColour excess in (B-V)magphot.color.excess;phot.color;em.opt.B;em.opt.Vfloatnullabledist_modApparent distance modulus in Ksmagphot.mag.distModfloatnullablecol_ex_jColour excess in (J-Ks)magphot.color.excess;phot.color;em.ir.J;em.ir.Kfloatnullablecol_ex_hColour excess in (J-H)magphot.color.excess;phot.color;em.ir.J;em.ir.Hfloatnullabledelta_hCorrection to H mag of fitted isochrone, empirically introduced to achieve a better fit in the Ks vs. J-H CMD. (see 2012A&A...543A.156K).magphot.mag;arith.difffloatnullablelogtLogarithm of average agelog(yr)time.age;stat.meanfloatindexednullablee_logtError in logarithm of average agelog(yr)stat.error;time.agefloatnullablentNumber of stars used for log(T) calculationmeta.numberintnullablercKing core radiuspcphys.size.radiusfloatnullablee_rcError of King core radiuspcstat.error;phys.size.radiusfloatnullablertKing tidal radiuspcphys.size.radiusfloatnullablee_rtError of King tidal radiuspcstat.error;phys.size.radiusfloatnullablekingkKing normalization factor (a measure of the central density of the cluster, see 2007A&A...468..151Ppc**-2stat.fit.paramfloatnullablee_kingkError of King normalization factorpc**-2stat.error;stat.fit.paramfloatnullablefe_hMetallicity [Fe/H]; this is copied from 2013arXiv1309.4325C or 2012A&A...539A.125D. Data for globular clusters is taken from the revised Harris (1996) catalogue, edition 2010, or newly determined.phys.abund.Fefloatindexednullablee_fe_hError of Metallicitystat.error;phys.abund.Fefloatnullablen_fe_hNumber of objects in [Fe/H] calculation.meta.numbershortnullablenote_textThe text of the note for an object.meta.notecharnullable
mwsce14a.stars +MWSC-e14a ("MWSC extension 2014a") is a catalogue of +139 new open clusters at high Galactic latitudes +(\|b\|>20 deg) including lists of candidate members. It extends the +Kharchenko et al. 'Catalog of Milky Way Star Clusters'. +The target list was compiled as density enhancements found in the 2MASS +point source catalogue. For confirmed clusters we determined a homogeneous +set of astrophysical parameters such as membership, angular radii of the +main morphological parts, proper motion, distance, reddening, age, and +tidal parameters. + +.. _Catalog of Milky Way Star Clusters: http://dc.g-vo.org/mwsc/q/clu/form519163recnoMWSC number of the cluster containing the star.meta.id;meta.maincharindexedraj2000Stellar Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Stellar Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablemagbB magnitude in Johnson system.magphot.mag;em.opt.BfloatnullablemagvV magnitude in Johnson system.magphot.mag;em.opt.VfloatindexednullablemagjMagnitude in the 2MASS J bandmagphot.mag;em.ir.Jfloatindexednullablee_magjError in the magnitude in the 2MASS J bandmagstat.error;phot.mag;em.ir.JfloatnullablemaghMagnitude in the 2MASS H bandmagphot.mag;em.ir.Hfloatnullablee_maghError in the magnitude in the 2MASS H bandmagstat.error;phot.mag;em.ir.HfloatnullablemagksMagnitude in the 2MASS Ks bandmagphot.mag;em.ir.Kfloatnullablee_magksError in the magnitude in the 2MASS Ks bandmagstat.error;phot.mag;em.ir.KfloatnullablepmraStellar proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.rafloatnullablepmdeStellar proper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmError of stellar proper motiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablervStellar radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableqflg2MASS JHK photometric quality flagmeta.code.qual;photcharnullablerflg2MASS photometric read flagmeta.refcharnullablebflg2MASS photometric blend flagmeta.codecharnullabletwomassidUnique identifier in 2MASS (pts_key)meta.id.crossintasccIdentifier in ASCC 2.5meta.id.crossintnullablespectralSpectral type and luminosity classsrc.spTypecharnullabler_clAngular distance from cluster centredegpos.angDistancefloatnullablep_spatProbability of membership from spatial propertiesstat.probabilityfloatindexednullablep_kinProbability of membership from kinetic propertiesstat.probabilityfloatindexednullablep_jksProbability of membership from J, Ks photometrystat.probabilityfloatindexednullablep_jhProbability of membership from J, H photometrystat.probabilityfloatnullablemwsce14a.mainrecnorecno
obscodeObservatory Codes List of Observatory Codes assigned by the Minor Planet Center (MPC). +The codes are used in cataloguing astrometric observations of small +bodies in the solar system. A code is unique for a certain location +and consists of three digits or one letter and two digits. + +In this representation, we give the observatory code, the geocentric +coordinates, and the observatory designation.obscode.data List of Observatory Codes assigned by the Minor Planet Center (MPC). +The codes are used in cataloguing astrometric observations of small +bodies in the solar system. A code is unique for a certain location +and consists of three digits or one letter and two digits. + +In this representation, we give the observatory code, the geocentric +coordinates, and the observatory designation.2280codeObservatory Code assigned by the Minor Planet Centermeta.idcharnullablelongLongitude of the observatorydegpos.earth.lonfloatnullablecosphipParallax constant, cosinefloatnullablesinphipParallax constant, sinefloatnullablegclatGeocentric latitude of the observatorydegpos.earth.lat;pos.geocentricfloatnullablegdlatGeodetic latitude of the observatory WGS84degpos.earth.lat;pos.geocentricfloatnullableheightAltitude of the observatorympos.earth.altitudefloatnullablenameOperator-chosen designation of the Observatorymeta.id;meta.maincharnullable
ohmaserA Database of Circumstellar OH MasersA all-sky compilation of galactic stellar sources observed for OH +maser emission in the transitions at 1612, 1665, and 1667 MHz. The +database contains OH maser observations selected from the literature . +These observations belong to more than 6000 different objects. The +database consists of three tables: The main table ("masers"), +interferometric followup observations ("maps") and monitoring programs +("monitor").ohmaser.bibrefsBibliographic and other metadata on the sources of the data in the +masers table.314ref_keyInternal key for the papercharindexedprimarybibcodeBibliographic reference to the data sourcemeta.bibcharnullablemodificationsModifications applied to data given in papercharnullablecommentsCompilators' CommentscharnullabletextrefHuman-readable reference to workcharnullabledet1612Sources detected at 1612 MHzintnullablendet1612Sources not detected at 1612 MHzintnullabledet1665Sources detected at 1665 MHzintnullablendet1665Sources not detected at 1665 MHzintnullabledet1667Sources detected at 1667 MHzintnullablendet1667Sources not detected at 1667 MHzintnullablecoosrcSource of coordinates given in databasecharnullableinputtablesTables evaluated from cited papercharnullable
ohmaser.masersMaser data proper.13655measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintflagNon-null if this measurement is considered the best available at a particular frequency. Lower means higher confidence.meta.codeshortnullablesource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharfrequencyObserved frequencyMHzem.freqintnullablespec_typeS -- Single peak of maser emission; D -- Double peak of maser emission; I -- Irregular spectral profile, multiple emission peaks.meta.code;src.spTypecharnullablera_rawJ2000 RApos.eq.racharnullablede_rawJ2000 Decpos.eq.deccharnullableveloc_blueVelocity of the blue-shifted maser peak. For single-peak masers it contains the line velocity.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_redVelocity of the red-shifted maser peak in km/s. It contains the line velocity for a single peak maser if it corresponds to the red-shifted peak in other observations.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_centralRadial velocity of the central star. If veloc_central is not given in the reference, it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_shellOutflow Velocity of the shell. If vexp is not given in the reference it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_errUncertainty of velocity values. Taken from the velocity resolution of the observation. It is actually a lower limit of the uncertainty, because the lines are usually much broader than velocity resolution of the observing equipment.km/sstat.error;phys.veloc.expansion;pos.bodyrcfloatnullableflux_dens_flagNULL -- flux density columns contain detections; < -- non-detection at level flux density blue (3 sigma); > -- flux density blue contains a lower limit for the flux; = -- source only gives fluxes; . -- flux density blue contains probable detection; : -- flux density red contains probable detection; & -- both flux densities contain probable detectionsmeta.codecharnullableflux_dens_blueFlux Density of the blue-shifted maser peak. For single-peak masers it contains its flux density.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableflux_dens_redFlux Density of the red-shifted maser peak. It contains the flux density for a single peak maser, if it corresponds to the red-shifted peak in other observations.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_redIntegrated flux of red peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_blueIntegrated flux of blue peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullablerapubRA of object, from sourcedegpos.eq.rafloatnullabledepubDec of object, from sourcedegpos.eq.decfloatnullableraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoubleindexednullablemapurlURL to information on an interferometric followup observation for this object.meta.ref.urlcharnullablemonitorurlURL to information on a monitor programme for this object.meta.ref.urlcharnullableohmaser.bibrefsref_keyref_key
ohmaser.mapsTable of interferometric measurements included.271measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableinstrumentName of the interferometer usedmeta.id;instrcharnullableresolutionSpatial resolution of the observationmasinstr.paramfloatnullablenon_det_flag< if observation is a non-detection.meta.codecharnullablermsRMS sensitivity of the observationJyinstr.sensitivityfloatnullablen_mapsNumber of maps obtained between obs_date_start and obs_date_endmeta.number;obsshortnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullableohmaser.maserssource_nosource_no
ohmaser.monitorTable of measurements included from monitoring programs.180measure_noUnique measurement identifiermeta.id;meta.mainintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharsource_noUnique, artificial source identifiermeta.codeintraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullablemax_flux_dens_flag< if max_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemax_flux_dens_peakMaximal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.maxfloatnullablemin_flux_dens_flag< if min_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemin_flux_dens_peakMinimal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.minfloatnullableohmaser.maserssource_nosource_no
onebigb1BIGB: First Brazil-ICRANet Gamma-Ray Blazar Catalogue +This catalog presents the 1-100 GeV spectral energy distribution (SED) +for a population of 148 high-synchrotron-peaked blazars (HSPs) recently +detected with Fermi-LAT as part of the +First Brazil-ICRANet Gamma-ray Blazar catalogue (1BIGB). +A series of two works describe details on the broadband analysis: +:bibcode:`2017A&A...598A.134A`, and the calculation of the +gamma-ray SEDs :bibcode:`2018MNRAS.480.2165A`. + +The 1BIGB sample was originally selected from an excess signal in the +0.3-500 GeV band The flux estimates presented here are derived considering +PASS8 data, integrating over more than 9 years of Fermi-LAT observations. The +full broadband fit between 0.3-500 GeV presented in paper 1 for all sources +was reevaluated in paper 2, updating the power-law parameters with currentlyonebigb.measurementsA table of raw measurement points. See the seds table for combined +SEDs.1329idDatapoint IDmeta.id;meta.mainintiauidIAU-compliant identifier of the Blazarmeta.idcharnullableraRight Ascensiondegpos.eq.ra;meta.maindoublenullabledecDeclinationdegpos.eq.dec;meta.maindoublenullablefrequencyFlux measurement frequencyHzem.freqfloatnufnunuFnu Fluxerg.cm**-2.s**-1phot.fluxfloatnufnu_errornuFnu Flux errorerg.cm**-2.s**-1stat.error;phot.fluxfloatupper_limitFlux upper limitmeta.codecharnullable
onebigb.ssaSSA-compliant table of SEDs constructedaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperturedoubleindexednullablefrequencyFlux measurement frequencyHzem.freqfloatnufnunuFnu Fluxerg.cm**-2.s**-1phot.fluxfloatnufnu_errorError in nuFnu; a zero here indicates an upper limiterg.cm**-2.s**-1stat.error;phot.fluxfloat
openngcOpenNGC OpenNGC is a database containing positions and main data of NGC (New +General Catalogue) and IC (Index Catalogue) objects. It has been built +by merging data from NED, HyperLEDA, SIMBAD, and several databases +available at HEASARC. + +In this VO publication, we have changed most of the column names, +mostly to make them work as ADQL column names without resorting to +delimited identifiers. The mapping should be obvious.openngc.dataThe OpenNGC object list with the main metadata13969nameObject identifier, either from NGC or from IC.meta.id;meta.maincharindexednullableobj_typeObject Type. See note for terms and symbols used.src.classcharindexednullableraj2000Right Ascension in ICRS for Epoch J2000.0.degpos.eq.ra;meta.maindoublenullabledej2000Declination in ICRS for Epoch J2000.0.degpos.eq.dec;meta.maindoublenullableconstellationConstellation the object is located in.meta.id.parentcharnullablemaj_ax_degMajor axis of covering ellipsoid.degphys.angSize.sMajAxisfloatnullablemin_ax_degMinor axis of covering ellipsoid.degphys.angSize.sMinAxisfloatnullablepos_angPosition angle of covering ellipsoid, north over east.degpos.posAngfloatnullablemag_bApparent total magnitude in the B Band.magphot.mag;em.opt.Bfloatnullablemag_vApparent total magnitude in the V Band.magphot.mag;em.opt.Vfloatnullablemag_jApparent total magnitude in the J Band.magphot.mag;em.ir.Jfloatnullablemag_hApparent total magnitude in the H Band.magphot.mag;em.ir.Hfloatnullablemag_kApparent total magnitude in the K Band.magphot.mag;em.ir.Kfloatnullablesurf_br_bMean surface brigthness within the 25 mag isophote (B-band); only given for galaxiesmag/arcsec**2phot.mag.sbfloatnullablehubble_typeMorphological Hubble type for galaxies.src.morph.typecharindexednullablepmraProper motion in RAmas/yrpos.pm;pos.eq.rafloatnullablepmdecProper motion in Declinationmas/yrpos.pm;pos.eq.decfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVelocfloatnullablezHeliocentric redshiftsrc.redshiftfloatnullablecstar_mag_uFor planetary nebulae: Apparent magnitude of the central star in the U Band.magphot.mag;em.opt.Ufloatnullablecstar_mag_bFor planetary nebulae: Apparent magnitude of the central star in the B Band.magphot.mag;em.opt.Bfloatnullablecstar_mag_vFor planetary nebulae: Apparent magnitude of the central star in the V Band.magphot.mag;em.opt.Vfloatnullablemessier_nrMessier number for this objectmeta.id.crossintnullableother_ngcOther NGC number for this object in case it was duplicated in IC or NCG.meta.id.crosscharnullableic_crossOther IC number for this object in case it was duplicated in IC or NCG.meta.id.crosscharnullablecstar_idIdentifier of the central star for planetary nebulae.meta.id.crosscharnullableother_idCross reference to other catalogs.meta.id.crosscharnullablecomnameCommon name(s) of the object.charnullablened_notesNotes about the object exported from NEDmeta.notecharnullablesourcesSources of the various categories of datameta.bibcharnullablenotesNotes about the object from OpenNGCmeta.notecharnullable
openngc.shapes Hand-drawn coverages of selected openngc objects. Up to three +coverages at different surface brightness are obtained using the +default DSS2 Color layer in Aladin. Usually, the level 2 shape is +taken with default histogram, while level 1 and level 3 use, +respectvely, the first and the last half of the histogram.193nameName of the (main) object the coverage is for.meta.idcharindexedprimaryshape_level1Coverage obtained by tracing the object's outline visually in DSS colour, with full output intensity at half saturation.phys.angAreacharnullableshape_level2Coverage obtained by tracing the object's outline visually in DSS colour, with zero output intensity at zero saturation and full output intensity at full saturation.phys.angAreacharnullableshape_level3Coverage obtained by tracing the object's outline visually in DSS colour, with zero output intensity at half saturation and full output intensity at full saturation.phys.angAreacharnullabledeepest_shapeDeepest coverage available. As opposed to the other shape columns, this will always contain something as long as we have some coverage information; this is provided for convenience.phys.angArea;meta.maincharnullableopenngc.datanamename
pccA Catalog of Galaxies in the Direction of the Perseus Cluster This is a catalog of 5437 morphologically classified sources in the +direction of the Perseus galaxy cluster core, among them 496 +early-type low-mass galaxy candidates. The catalog is primarily based +on V-band imaging data acquired with the William Herschel Telescope. +Additionally, we used archival Subaru multiband imaging data in order +to measure aperture colors and to perform a morphological +classification. The catalog reaches its 50 per cent completeness limit +at an absolute V-band luminosity of -12 mag and a V-band surface +brightness of 26 mag arcsec^-2 . + +In addition to the published table, this service also contains cutout +images of the objects investigated.pcc.main This is a catalog of 5437 morphologically classified sources in the +direction of the Perseus galaxy cluster core, among them 496 +early-type low-mass galaxy candidates. The catalog is primarily based +on V-band imaging data acquired with the William Herschel Telescope. +Additionally, we used archival Subaru multiband imaging data in order +to measure aperture colors and to perform a morphological +classification. The catalog reaches its 50 per cent completeness limit +at an absolute V-band luminosity of -12 mag and a V-band surface +brightness of 26 mag arcsec^-2 . + +In addition to the published table, this service also contains cutout +images of the objects investigated.object_nameIdentifier from Wittman et al (2019).meta.id;meta.maincharindexedprimaryraICRS Right Ascension from WHT imagedegpos.eq.ra;meta.maindoubleindexednullabledecICRS Declination from WHT imagedegpos.eq.dec;meta.maindoubleindexednullablemagIntegrated V-band apparent magnitude corrected for extinction.magphot.mag;em.opt.Vdoublenullableerr_magError in integrated apparent magnitude for sources fitted with GALFIT (i.e., pflag = 1 .. 8; NULL otherwise)magstat.error;phot.mag;em.opt.Vfloatnullabler_50Half-light radius in the V band..arcsecphys.angsizefloatnullableerr_r_50Error in half-light radius in the V band.arcsecstat.error;phys.angsizefloatnullablemu50Effective V band surface brightness within R_50 corrected for extinctionmag.arcsec**-2phot.mag.sbfloatnullableerr_mu50Error in the effective surface brightness propagated from err_mag and err_r_50mag.arcsec**-2stat.error;phot.mag.sbfloatnullablesersic_indexSérsic index, upper limit constrained to 4 (cf. paper, sect. 4.3)stat.fit.paramfloatnullableerr_sersic_indexError in Sérsic index for sources fitted with GALFIT with free N parameter (pflag = 1)stat.error;stat.fit.paramfloatnullableb_aAxis ratio in the V band for sources fitted with GALFIT (pflag = 1 .. 8)phys.angsize;arith.ratiofloatnullableerr_b_aError in axis ratio for sources fitted with GALFIT with free B/A parameter (pflag = 1 - 4)stat.error;phys.angsize;arith.ratiofloatnullablepaPosition Angle for sources fitted with GALFIT and b_a < 0.9 [North/Up=0, East/Left=90]; from V band.degpos.posangfloatnullableerr_paError in position angle.degstat.error;pos.posangfloatnullablea_vV-band galactic foreground extinction.magphys.absorption;em.opt.VfloatnullablepflagPhotometry processing flag (see note).meta.codeshortresflag1 if there were significant residuals after substracting GALFIT model, 0 otherwise. This is only given for sources fitted with GALFIT (i.e., pflag = 1 .. 8)meta.code.qualshortnullablebgflagBackground fitted with: ...0: Galfit; ...1: SExtractor with BACK_SIZE = 256 pixel background map, ...2: like 1, but BACK_SIZE = 32 pixelmeta.codeshortg_r_1Subaru g-r for aperture 1, color corrected for extinction. (r_aper1 = 1 R50 for sources with R50 > 4 pixels, r_aper1 = 4 pixels for sources with R50 <= 4 pixels)magphot.color;em.opt.V;em.opt.Rfloatnullableerr_g_r_1Error in g-r for aperture 1magphot.color;em.opt.V;em.opt.Rfloatnullabler_z_1Subaru r-z for aperture 1, color corrected for extinction. (r_aper1 = 1 R50 for sources with R50 > 4 pixels, r_aper1 = 4 pixels for sources with R50 <= 4 pixels)magphot.color;em.opt.R;em.opt.Ifloatnullableerr_r_z_1Error in r-z for aperture 1magphot.color;em.opt.R;em.opt.Ifloatnullableg_r_2Subaru g-r for aperture 2, color corrected for extinction. (only for sources with R50 > 4 pixels, where r_aper2 = 2 R50)magphot.color;em.opt.V;em.opt.Rfloatnullableerr_g_r_2Error in g-r for aperture 2magphot.color;em.opt.V;em.opt.Rfloatnullabler_z_2Subaru r-z for aperture 2, color corrected for extinction. (only for sources with R50 > 4 pixels, where r_aper2 = 2 R50)magphot.color;em.opt.R;em.opt.Ifloatnullableerr_r_z_2Error in r-z for aperture 2magphot.color;em.opt.R;em.opt.Ifloatnullableg_r_flag1 if g-r photometry possibly comtaminated through bleeding trails of bright stars within 3 arcsec, 0 otherwisemeta.code.qualshortnullabler_z_flag1 if r-z photometry possibly comtaminated through bleeding trails of bright stars within 3 arcsec, 0 otherwisemeta.code.qualshortnullablea_gg-band galactic foreground extinction.magphys.absorption;em.opt.Vfloatnullablea_rr-band galactic foreground extinction.magphys.absorption;em.opt.Rfloatnullablea_zz-band galactic foreground extinction.magphys.absorption;em.opt.IfloatnullablemorphologyMorphological classificationsrc.classcharnullablenucleationRemark on nucleationsrc.classcharnullablecutout_linkLink to a FITS cutout for this source from an r-band mosaic. See datalink for additional retrieval options.meta.ref.urlcharnullable
plcCandidates for astrometric microlensingA catalogue of candidate stars for observing astrometric microlensing +using Gaia.plc.dataThe final candidate table with estimates of minimal distances, epochs, +etc.8932sourceSource of the data of the lensmeta.codecharnullablesrcidId of lensing objectmeta.id;meta.maincharnullablelensalphaJ2000 PPMX alpha of lensdegpos.eq.ra;meta.maindoubleindexednullablelensdeltaJ2000 PPMX delta of lensdegpos.eq.dec;meta.maindoubleindexednullablelensalphaerrError of lens alphadegstat.error;pos.eq.ra;meta.mainfloatnullablelensdeltaerrError of lens deltadegstat.error;pos.eq.dec;meta.mainfloatnullablelenspmalphaLens PM in alpha, cos(delta) applieddeg/yrfloatnullablelenspmdeltaLens PM in deltadeg/yrfloatnullablelenspmalphaerrError of Lens PM in alphadeg/yrfloatnullablelenspmdeltaerrError of Lens PM in deltadeg/yrfloatnullablelensmagPPMX catalogue magnitude of lensmagfloatnullablelensrmagPPMX Ru mag of lensmagfloatnullablelensbmagLens B mag as in PPMXmagfloatnullablelensvmagLens V mag as in PPMXmagfloatnullablelensjmagLens J mag as in PPMXmagfloatnullablelenshmagLens H mag as in PPMXmagfloatnullablelenskmagLens K mag as in PPMXmagfloatnullableobalphaJ2000 USNO alpha of lensed objectdegdoublenullableobdeltaJ2000 USNO delta of lensed objectdegdoublenullableobalphaerrPositional error of lensed object in alphadegfloatnullableobdeltaerrPositional error of lensed object in deltadegfloatnullableobpmalphaObject PM in alphadeg/yrfloatnullableobpmdeltaObject PM in deltadeg/yrfloatnullableobpmalphaerrError of Object PM in alphadeg/yrfloatnullableobpmdeltaerrError of Object PM in deltadeg/yrfloatnullableobbUSNO-B B mag magnitude of lensedfloatnullableobrUSNO-B R mag magnitude of lensedfloatnullableobiUSNO-B I mag magnitude of lensedfloatnullableobj2MASS J mag magnitude of lensedfloatnullableobh2MASS H mag magnitude of lensedfloatnullableobk2MASS K mag magnitude of lensedfloatnullablemindateEstimated time of closest approach (julian year)yrfloatnullablemindateerrError in estimation of time of closest approachyrfloatnullablemindistEstimated minimal distancedegfloatnullablemindisterrError in estimation of minimal distancedegfloatnullableconfirmed1 if lensing event confirmedboolean
plc2Astrometric Microlensing Events Predicted from Gaia DR2 From the Gaia DR2 catalogue we predict astrometric microlensing +events by foreground stars with high proper motion (µ_tot >150mas/yr) +passing a background source in the next decades. Using Gaia DR2 +photometry we determine an approximate mass of the lens, which we use +to calculate the expected microlensing effects. This yields 3914 +microlensing events by 2875 different lenses between 2010 and 2065 +with expected shifts larger than 0.1 mas between the lensed and +unlensed positions of the source. 513 of those are expected to happen +between 2014.5 - 2026.5 and might be measured by Gaia. For 127 events +we also expect a magnification between 1 mmag and 3 mag.plc2.dataThe final candidate table for astrometric microlensing events +predicted from Gaia DR2. This has estimates of minimal distances, +epochs, etc. Columns prefixed with lens_ are for the lens, columns +prefixed with ob_ are for the lensed object.3914event_idUnique identifier of this event. This is the decimal representation of the Gaia DR2 source_id of the lens, and a disambiguator for the lensed object.meta.id;meta.maincharindexedprimarylens_idGaia DR2 source_id of the lens.meta.idlonglens_raGaia DR2 RA of the lensdegpos.eq.ra;meta.maindoubleindexednullablelens_decGaia DR2 Declication of the lensdegpos.eq.dec;meta.maindoubleindexednullablelens_err_raError of lens__ra from Gaia DR2degstat.error;pos.eq.ra;meta.mainfloatnullablelens_err_decError of lens__dec from Gaia DR2degstat.error;pos.eq.dec;meta.mainfloatnullablelens_pmraProper motion in RA of the lens from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullablelens_pmdecProper motion in Declination of the lens from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullablelens_err_pmraError of lens_pmra from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullablelens_err_pmdecError of lens_pmdec from Gaia DR2deg/yrpos.pm;pos.eq.decfloatnullablelens_parallaxParallax of the lens from Gaia DR2degpos.parallaxfloatnullablelens_err_parallaxStandard error of the parallax the lens from Gaia DR2degstat.error;pos.parallaxfloatnullablelens_phot_g_mean_magMean magnitude of the lens in the integrated G band from Gaia DR2.magphot.mag;em.opt.Vfloatnullablelens_phot_rp_mean_magMean magnitude of the lens in the integrated RP band from Gaia DR2.magphot.mag;em.opt.Rfloatnullablelens_phot_bp_mean_magMean magnitude of the lens in the integrated BP band from Gaia DR2.magphot.mag;em.opt.Bfloatnullableob_idGaia DR2 source_id of the lensed object.meta.idlongob_raGaia DR2 RA of the lensed objectdegpos.eq.radoublenullableob_decGaia DR2 Declication of the lensed objectdegpos.eq.decdoublenullableob_err_raError of ob__ra from Gaia DR2degstat.error;pos.eq.rafloatnullableob_err_decError of ob__dec from Gaia DR2degstat.error;pos.eq.decfloatnullableob_pmraProper motion in RA of the lensed object from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullableob_pmdecProper motion in Declination of the lensed object from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullableob_err_pmraError of ob_pmra from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullableob_err_pmdecError of ob_pmdec from Gaia DR2deg/yrpos.pm;pos.eq.decfloatnullableob_parallaxParallax of the lensed object from Gaia DR2degpos.parallaxfloatnullableob_err_parallaxStandard error of the parallax the lensed object from Gaia DR2degstat.error;pos.parallaxfloatnullableob_phot_g_mean_magMean magnitude of the lensed object in the integrated G band from Gaia DR2.magphot.mag;em.opt.Vfloatnullableob_phot_rp_mean_magMean magnitude of the lensed object in the integrated RP band from Gaia DR2.magphot.mag;em.opt.Rfloatnullableob_phot_bp_mean_magMean magnitude of the lensed object in the integrated BP band from Gaia DR2.magphot.mag;em.opt.Bfloatnullablestar_typeType of the lensing star: WD = White Dwarf, MS = Main Sequence, RG = Red Giant, BD = Brown Dwarfsrc.classcharnullablemassEstimated mass of the lens from Gaia DR2solMassphys.massfloatnullableerr_massError in the mass of the lens from Gaia DR2solMassstat.error;phys.massfloatnullabletheta_eEinstein radius of the eventmasphys.angsizedoublenullableerr_theta_eError in the Einstein radius of the eventmasstat.error;phys.angsizefloatnullabletime_scaleApproximate duration of the eventyrtime.durationdoublenullabletcaEstimated time of the closest approach.yrtime.epochdoublenullableerr_tcaError in tca.yrstat.error;time.epochfloatnullabledistEstimated distance at closest approach.maspos.angdistancefloatnullableerr_distError d_min.masstat.error;pos.angdistancefloatnullableuEstimated distance at closest approach in Einstein radii.doublenullableerr_uError in u.floatnullableshiftMaximal astrometric shift of the center of light.maspos;arith.diffdoublenullableerr_shiftError in shiftmasstat.error;pos;arith.difffloatnullableshift_lumMaximal astrometric shift including lens-luminosity effects.maspos;arith.diffdoublenullableerr_shift_lumError in shift_lum.masstat.error;pos;arith.difffloatnullableshift_plusMaximal astrometric shift of brighter image.maspos;arith.diffdoublenullableerr_shift_plusError in shift_plus.masstat.error;pos;arith.difffloatnullablemagnificationMaximal magnification.magphot.mag;arith.ratiodoublenullableerr_magnificationError in magnification.magstat.error;phot.mag;arith.ratiofloatnullablel2_tcaEstimated time of the closest approachas seen from Earth-Sun L2 point.yrtime.epochdoublenullablel2_err_tcaError in l2_tca.yrstat.error;time.epochfloatnullablel2_distEstimated distance at closest approachas seen from Earth-Sun L2 point.maspos.angdistancefloatnullablel2_err_distError l2_d_min.masstat.error;pos.angdistancefloatnullablel2_uEstimated distance at closest approach in Einstein radiias seen from Earth-Sun L2 point.doublenullablel2_err_uError in l2_u.floatnullablel2_shiftMaximal astrometric shift of the center of lightas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_err_shiftError in l2_shiftmasstat.error;pos;arith.difffloatnullablel2_shift_lumMaximal astrometric shift including lens-luminosity effectsas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_err_shift_lumError in l2_shift_lum.masstat.error;pos;arith.difffloatnullablel2_shift_plusMaximal astrometric shift of brighter imageas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_err_shift_plusError in l2_shift_plus.masstat.error;pos;arith.difffloatnullablel2_magnificationMaximal magnificationas seen from Earth-Sun L2 point.magphot.mag;arith.ratiodoublenullablel2_err_magnificationError in l2_magnification.magstat.error;phot.mag;arith.ratiofloatnullable
plc3Astrometric Microlensing Events Predicted from Gaia eDR3 From the Gaia eDR3 catalogue we predict astrometric microlensing +events by foreground stars with high proper motion (μ > 100 mas/yr) +passing a background source in the next decades. Using Gaia DR3 +photometry we determine an approximate mass of the lens, which we use +to calculate the expected microlensing effects. This yields 4842 +microlensing events by 3791 different lenses between 2010 and 2066 +with expected shifts larger than 0.1 mas between the lensed and +unlensed positions of the source. The past events might be interested +when analyzing the individual Gaia measurements). 685 of those are +expected to happen within the next decade (2021-2031). For 140 events +we also expect a magnification between 1 mmag and 0.6 mag.plc3.dataThe final candidate table for astrometric microlensing events +predicted from Gaia eDR3. This has estimates of minimal distances, +epochs, etc. Columns prefixed with lens_ are for the lens, columns +prefixed with ob_ are for the lensed object.4842event_idUnique identifier of this event. This is the decimal representation of the Gaia eDR3 source_id of the lens, and a disambiguator for the lensed object.meta.id;meta.maincharindexedprimarylens_idGaia eDR3 source_id of the lens.meta.idlonglens_raGaia eDR3 RA of the lensdegpos.eq.ra;meta.maindoubleindexednullablelens_decGaia eDR3 Declination of the lensdegpos.eq.dec;meta.maindoubleindexednullablelens_err_raError of lens__ra from Gaia eDR3masstat.error;pos.eq.ra;meta.mainfloatnullablelens_err_decError of lens__dec from Gaia eDR3masstat.error;pos.eq.dec;meta.mainfloatnullablelens_pmraProper motion in RA of the lens from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullablelens_pmdecProper motion in Declination of the lens from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullablelens_err_pmraError of lens_pmra from Gaia eDR3deg/yrpos.pm;pos.eq.rafloatnullablelens_err_pmdecError of lens_pmdec from Gaia eDR3deg/yrpos.pm;pos.eq.decfloatnullablelens_parallaxParallax of the lens from Gaia eDR3maspos.parallaxfloatnullablelens_err_parallaxStandard error of the parallax the lens from Gaia eDR3masstat.error;pos.parallaxfloatnullablelens_phot_g_mean_magMean magnitude of the lens in the integrated G band from Gaia eDR3.magphot.mag;em.opt.Vfloatnullablelens_phot_rp_mean_magMean magnitude of the lens in the integrated RP band from Gaia eDR3.magphot.mag;em.opt.Rfloatnullablelens_phot_bp_mean_magMean magnitude of the lens in the integrated BP band from Gaia eDR3.magphot.mag;em.opt.Bfloatnullableob_idGaia eDR3 source_id of the lensed object.meta.idlongob_raGaia eDR3 RA of the lensed objectdegpos.eq.radoublenullableob_decGaia eDR3 Declination of the lensed objectdegpos.eq.decdoublenullableob_err_raError of ob__ra from Gaia eDR3masstat.error;pos.eq.rafloatnullableob_err_decError of ob__dec from Gaia eDR3masstat.error;pos.eq.decfloatnullableob_pmraProper motion in RA of the lensed object from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullableob_pmdecProper motion in Declination of the lensed object from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullableob_err_pmraError of ob_pmra from Gaia eDR3deg/yrpos.pm;pos.eq.rafloatnullableob_err_pmdecError of ob_pmdec from Gaia eDR3deg/yrpos.pm;pos.eq.decfloatnullableob_parallaxParallax of the lensed object from Gaia eDR3maspos.parallaxfloatnullableob_err_parallaxStandard error of the parallax the lensed object from Gaia eDR3masstat.error;pos.parallaxfloatnullableob_phot_g_mean_magMean magnitude of the lensed object in the integrated G band from Gaia eDR3.magphot.mag;em.opt.Vfloatnullableob_phot_rp_mean_magMean magnitude of the lensed object in the integrated RP band from Gaia eDR3.magphot.mag;em.opt.Rfloatnullableob_phot_bp_mean_magMean magnitude of the lensed object in the integrated BP band from Gaia eDR3.magphot.mag;em.opt.Bfloatnullableob_displacement_ra_doubledDoubled Displacement in RA between DR2 and DR3, cos(δ) applied.maspos.eq.ra;arith.difffloatnullableob_displacement_dec_doubledDoubled Displacement in Dec between DR2 and DR3maspos.eq.dec;arith.difffloatnullablestar_typeType of the lensing star: WD = White Dwarf, MS = Main Sequence, RG = Red Giant, BD = Brown Dwarfsrc.classcharnullablemassEstimated mass of the lens from Gaia eDR3solMassphys.massfloatnullableerr_massError in the mass of the lens from Gaia eDR3solMassstat.error;phys.massfloatnullabletheta_eEinstein radius of the eventmasphys.angsizedoublenullableerr_theta_eError in the Einstein radius of the eventmasstat.error;phys.angsizefloatnullablet_amlApproximate duration of the event (i.e., shift > ~0.1 mas).yrtime.durationdoublenullabletcaEstimated time of the closest approach.yrtime.epochdoublenullableerr_tcaError in tca.yrstat.error;time.epochfloatnullabledistEstimated distance at closest approach.maspos.angdistancefloatnullableerr_distError d_min.masstat.error;pos.angdistancefloatnullableuEstimated distance at closest approach in Einstein radii.pos.angdistance;stat.mindoublenullableu_error_mLeft 67% confidence interval of u.stat.error;pos.angdistance;stat.minfloatnullableu_error_pRight 67% confidence interval of u.stat.error;pos.angdistance;stat.minfloatnullableshiftMaximal astrometric shift of the center of light.maspos;arith.diffdoublenullableshift_error_mLeft 67% confidence interval of shift.masstat.error;pos;arith.difffloatnullableshift_error_pRight 67% confidence interval of shift.masstat.error;pos;arith.difffloatnullableshift_lumMaximal astrometric shift including lens-luminosity effects.maspos;arith.diffdoublenullableshift_lum_error_mLeft 67% confidence interval of shift_lum.masstat.error;pos;arith.difffloatnullableshift_lum_error_pRight 67% confidence interval of shift_lum.masstat.error;pos;arith.difffloatnullableshift_plusMaximal astrometric shift of brighter image.maspos;arith.diffdoublenullableshift_plus_error_mLeft 67% confidence interval of shift_plus.masstat.error;pos;arith.difffloatnullableshift_plus_error_pRight 67% confidence interval of shift_plus.masstat.error;pos;arith.difffloatnullablemagnificationMaximal magnification.magphot.mag;arith.ratiodoublenullablemagnification_error_mLeft 67% confidence interval of magnification.magstat.error;phot.mag;arith.ratiofloatnullablemagnification_error_pRight 67% confidence interval of magnification.magstat.error;phot.mag;arith.ratiofloatnullablel2_tcaEstimated time of the closest approachas seen from Earth-Sun L2 point.yrtime.epochdoublenullablel2_err_tcaError in l2_tca.yrstat.error;time.epochfloatnullablel2_distEstimated distance at closest approachas seen from Earth-Sun L2 point.maspos.angdistancefloatnullablel2_err_distError l2_d_min.masstat.error;pos.angdistancefloatnullablel2_uEstimated distance at closest approach in Einstein radiias seen from Earth-Sun L2 point.pos.angdistance;stat.mindoublenullablel2_u_error_mLeft 67% confidence interval of l2_u.stat.error;pos.angdistance;stat.minfloatnullablel2_u_error_pRight 67% confidence interval of l2_u.stat.error;pos.angdistance;stat.minfloatnullablel2_shiftMaximal astrometric shift of the center of lightas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_shift_error_mLeft 67% confidence interval of l2_shift.masstat.error;pos;arith.difffloatnullablel2_shift_error_pRight 67% confidence interval of l2_shift.masstat.error;pos;arith.difffloatnullablel2_shift_lumMaximal astrometric shift including lens-luminosity effectsas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_shift_lum_error_mLeft 67% confidence interval of l2_shift_lum.masstat.error;pos;arith.difffloatnullablel2_shift_lum_error_pRight 67% confidence interval of l2_shift_lum.masstat.error;pos;arith.difffloatnullablel2_shift_plusMaximal astrometric shift of brighter imageas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_shift_plus_error_mLeft 67% confidence interval of l2_shift_plus.masstat.error;pos;arith.difffloatnullablel2_shift_plus_error_pRight 67% confidence interval of l2_shift_plus.masstat.error;pos;arith.difffloatnullablel2_magnificationMaximal magnificationas seen from Earth-Sun L2 point.magphot.mag;arith.ratiodoublenullablel2_magnification_error_mLeft 67% confidence interval of l2_magnification.magstat.error;phot.mag;arith.ratiofloatnullablel2_magnification_error_pRight 67% confidence interval of l2_magnification.magstat.error;phot.mag;arith.ratiofloatnullablet_0_1_masApproximate duration on which shift_plus changes by 0.1 mas from its maximumyrtime.durationfloatnullablet_50pcApproximate duration on which shift_plus changes by 50% from its maximumyrtime.durationfloatnullable
pltsScans of the Palomar-Leiden Trojan Survey Plates +This service publishes plate scans of the Palomar-Leiden Troian +surveys conducted between 1960 and 1977. The surveys led to the +discovery of more than 2,000 asteroids (1,800 with orbital information), +with another 2,400 asteroids, including 19 Trojans, found after further +analysis of the plates. + +Note that because of the large size of the plates, in this service each +original plate is contained in two parts, marked with "_1" and "_2", +respectively. The central parts +of the two parts overlap.plts.data +This service publishes plate scans of the Palomar-Leiden Troian +surveys conducted between 1960 and 1977. The surveys led to the +discovery of more than 2,000 asteroids (1,800 with orbital information), +with another 2,400 asteroids, including 19 Trojans, found after further +analysis of the plates. + +Note that because of the large size of the plates, in this service each +original plate is contained in two parts, marked with "_1" and "_2", +respectively. The central parts +of the two parts overlap.699accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdVOX:Image_MJDateObsdoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableplatenumPlate IDmeta.idcharnullableplatepartScan index. Since the scanner used to digitise the plate was physically smaller than the plates, each plate scan consists of two parts. This number is either 1 or 2 correspondingly.meta.id.partshortwfpdb_idPlate identifier as in the WFPDBmeta.idcharnullableexposureEffective exposure timestime.duration;obs.exposurefloatnullableobsnotesObservation Notesmeta.notecharnullableemulsionEmulsion of the original plateinstr.plate.emulsioncharnullablepub_didPublisher data set id; this is an identifier for the dataset in question and can be used to retrieve the data through, e.g., datalink.meta.id;meta.maincharnullableobjectSpecial object on platemeta.idcharindexednullable
polcatsmcOptical Polarimetric Catalog for the SMC An optical polarimetric catalog for the Small Magelanic Cloud (SMC) +is presented. It gives intrinsic and observed polarizations in the +V-band for a total of 7207 stars located in the Northeast and Wing +sections of the SMC and part of the Magellanic Bridge.polcatsmc.data An optical polarimetric catalog for the Small Magelanic Cloud (SMC) +is presented. It gives intrinsic and observed polarizations in the +V-band for a total of 7207 stars located in the Northeast and Wing +sections of the SMC and part of the Magellanic Bridge.7207ctObject running numbermeta.id;meta.mainintraj2000Object Right Ascension ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Object Declination ICRSdegpos.eq.dec;meta.maindoubleindexednullablepol_obsObserved polarization in percent of total flux, obtained by determining the Q and U stokes parameters from V photometry in four different angles.floatnullablee_pol_obsError in observed polarization including pixel noise. The error is given in percent of the total flux.floatnullablepa_pol_obsPosition angle of the observed polarizationdegfloatnullablepol_intIntrinsic polarisation in per cent of total flux, obtained by substracting the foreground polarization due to Milky Way dust from the observed polarization pol_obs. See paper, chapter 3, for details on foreground determination.floatnullablee_pol_intError on the intrinsic polarisation, including errors on observed polarisation and the estimate of the polarization due to forground dust.floatnullablepa_pol_intPosition angle of the intrinsic polarisationdegfloatnullablevmagV band magnitude obtained by summing up the flux of the image pair in one frame and calibrating against several published catalogs (see Table 3 in the paper).magphot.mag;em.opt.Vfloatnullablee_vmagError in V band magnitude, including photon noise and dispersion in the magnitude calibration.magstat.error;phot.mag;em.opt.Vfloatnullable
ppakm31PPAKM31 – Optical Integral Field Spectroscopy of Star-Forming Regions +in M31 These observations cover five star-forming regions in the Andromeda +galaxy (M31) with optical integral field spectroscopy. Each has a +field of view of roughly 1 kpc across, at 10pc physical resolution. In +addition to the calibrated data cubes, we provide flux maps of the Hβ, +[OIII]5007, Hα, [NII]6583, [SII]6716 and [SII]6730 line emission. Line +fluxes have not been corrected for dust extinction. All data products +have associated error maps.ppakm31.maps Extracted narrow-band images.30accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsRepresentative date of observation. In reality, data contributing to this observation has typically been obtained over about a month.dtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldInternal designation of the field being observed.charnullablecube_idIVOA publisher DID of the originating cube.meta.ref.ivoidcharnullablecube_linkDatalink URL for the cube this line was extracted from. This can be used to access the cube using datalink.charnullable
ppakm31.cubes Spectral cubes of the fields. Look for these with full metadata in +the ivoa.obscore table, obs_collection 'ppakm31 cubes'.5accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullable
ppmxThe PPM-Extended (PPMX) catalogue of positions and proper motionsPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS +system containing astrometric and photometric information. Its +limiting magnitude is about 15.2 in the GSC photometric system.ppmx.dataPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS +system containing astrometric and photometric information. Its +limiting magnitude is about 15.2 in the GSC photometric system.19000000alphafloatMain value of right ascensiondegpos.eq.ra;meta.maindoubleindexednullabledeltafloatMain value of declinationdegpos.eq.dec;meta.maindoubleindexednullablec_xx coordinate of intersection of radius vector and unit spherepos.cartesian.xfloatnullablec_yy coordinate of intersection of radius vector and unit spherepos.cartesian.yfloatnullablec_zz coordinate of intersection of radius vector and unit spherepos.cartesian.zfloatnullablelocalidName (IAU convention HHMMSS.s+DDMMSS), p or f appended to desambiguatemeta.id;meta.maincharindexedprimarypmraProper Motion in RA*cos(delta)arcsec/yrpos.pm;pos.eq.rafloatnullablepmdeProper Motion in Decarcsec/yrpos.pm;pos.eq.decfloatnullableraerrMean error in RA*cos(DEmas) at epRAmasstat.error;pos.eq.rafloatnullabledecerrMean error in DE at epDEmasstat.error;pos.eq.decfloatnullablepmraerrMean error in pmRA*cos(DEmas)arcsec/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeerrMean error in pmDEarcsec/yrstat.error;pos.pm;pos.eq.rafloatnullableepraMean Epoch (RA)yrtime.epoch;pos.eq.racharnullableepdeMean Epoch (Dec)yrtime.epoch;pos.eq.deccharnullablecmagCatalogue magnitude from sourcemagphot.magfloatindexednullablermagcalculated Ru magnitude from sourcemagphot.mag;em.opt.RfloatnullablebmagB magnitude in Johnson systemmagphot.mag;em.opt.Bfloatnullablee_bmagStandard error on B magnitudemagstat.error;phot.mag;em.opt.BfloatnullablevmagV magnitude in Johnson systemmagphot.mag;em.opt.Vfloatindexednullablee_vmagStandard error on V magnitudemagstat.error;phot.mag;em.opt.VfloatnullablejmagJ magnitude in Johnson systemmagphot.mag;em.IR.Jfloatnullablee_jmagStandard error on J magnitudemagstat.error;phot.mag;em.IR.JfloatnullablehmagH magnitude in Johnson systemmagphot.mag;em.IR.Hfloatnullablee_hmagStandard error on H magnitudemagstat.error;phot.mag;em.IR.HfloatnullablekmagK magnitude in Johnson systemmagphot.mag;em.IR.Kfloatnullablee_kmagStandard error on K magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablen_obsnumber of observations in LSQ fitmeta.number;obsintnullablep_flagTrue if LSQ fit is badmeta.code.qualbooleansub_flagSubset flagmeta.codecharnullablesrccatSource cataloguemeta.refcharnullablesrcidStar identifier in the source cataloguemeta.id.crosscharnullablepm_totalTotal proper motionarcsec/yrpos.pmfloatindexednullableangle_pmPosition angle of total proper motiondegpos.posAng;pos.pmfloatnullable
ppmxlThe PPMXL Catalog +PPMXL is a catalog of positions, proper motions, 2MASS- and optical +photometry of 900 million stars and galaxies, aiming to be complete +down to about V=20 full-sky. It is the result +of a re-reduction of USNO-B1 together with 2MASS to the ICRS as +represented by PPMX. This service additionally provides improved proper +motions computed according to Vickers et al, 2016 +(:bibcode:`2016AJ....151...99V`).ppmxl.main +PPMXL is a catalog of positions, proper motions, 2MASS- and optical +photometry of 900 million stars and galaxies, aiming to be complete +down to about V=20 full-sky. It is the result +of a re-reduction of USNO-B1 together with 2MASS to the ICRS as +represented by PPMX. This service additionally provides improved proper +motions computed according to Vickers et al, 2016 +(:bibcode:`2016AJ....151...99V`).900000000ipixIdentifier (Q3C ipix of the USNO-B 1.0 object)meta.id;meta.mainlongindexedraj2000Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablee_raepraMean error in RA*cos(delta) at mean epochdegstat.error;pos.eq.ra;meta.mainfloatnullablee_deepdeMean error in Dec at mean epochdegstat.error;pos.eq.dec;meta.mainfloatnullablepmraProper Motion in RA*cos(delta)deg/yrpos.pm;pos.eq.rafloatindexednullablepmdeProper Motion in Decdeg/yrpos.pm;pos.eq.decfloatindexednullablee_pmraMean error in pmRA*cos(delta)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error in pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobsNumber of observations usedmeta.number;obsshortnullableepraMean Epoch (RA)yrtime.epoch;pos.eq.rafloatnullableepdeMean Epoch (Dec)yrtime.epoch;pos.eq.decfloatnullablejmagJ selected default magnitude from 2MASSmagphot.mag;em.IR.Jfloatnullablee_jmagJ total magnitude uncertaintymagstat.error;phot.mag;em.IR.JfloatnullablehmagH selected default magnitude from 2MASSmagphot.mag;em.IR.Hfloatnullablee_hmagH total magnitude uncertaintymagstat.error;phot.mag;em.IR.HfloatnullablekmagK_s selected default magnitude from 2MASSmagphot.mag;em.IR.Kfloatnullablee_kmagK_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullableb1magB mag from USNO-B, first epochmagphot.mag;em.opt.Bfloatnullableb2magB mag from USNO-B, second epochmagphot.mag;em.opt.Bfloatnullabler1magR mag from USNO-B, first epochmagphot.mag;em.opt.Rfloatnullabler2magR mag from USNO-B, second epochmagphot.mag;em.opt.RfloatnullableimagI mag from USNO-Bmagphot.mag;em.opt.IfloatnullablemagsurveysSurveys the USNO-B magnitudes are taken frommeta.codecharnullableflagsFlagsmeta.codeshortvickers_pmraProper motion in RA as re-corrected according to 2016AJ....151...99V, cos(delta) applied. This is only available for objects with 2MASS J magnitudes. e_pmRA still is suitable as an error estimate.deg/yrpos.pm;pos.eq.rafloatnullablevickers_pmdeProper motion in Dec as re-corrected according to 2016AJ....151...99V. This is only available for objects with 2MASS J magnitudes. e_pmDE still is suitable as an error estimate.deg/yrpos.pm;pos.eq.decfloatnullable
ppmxl.usnocorrCorrections between USNO-B1 and PPMXL on a grid of degrees, obtained +by substracting PPMXL from USNO in cones of radius sqrt(2)/2 degrees +around the given center position.64800nobNumber of objects the correction is based onmeta.numberintalphaCenter for field, RAdegpos.eq.ra;meta.mainfloatindexednullabledeltaCenter for field, Decdegpos.eq.dec;meta.mainfloatindexednullabled_alphaCorrection PPMXL-USNO in alpha (Epoch 2000.0)degpos.eq.ra;arith.difffloatnullabled_deltaCorrection PPMXL-USNO in delta (Epoch 2000.0)degpos.eq.dec;arith.difffloatnullabled_pmalphaCorrection PPMXL-USNO in proper motion alpha*cos(delta)deg/yrpos.pm;pos.eq.ra;arith.difffloatnullabled_pmdeltaCorrection PPMXL-USNO in deltadeg/yrpos.pm;pos.eq.dec;arith.difffloatnullable
prdustBayestar17 3D Dust Mapping with Pan-STARRS 1 +A 3D map of interstellar dust reddening, covering three +quarters of the sky (declinations greater than -30 degrees) out to a +distance of several kiloparsecs. The map is based on high-quality stellar +photometry of 800 million stars from Pan-STARRS 1 and 2MASS. + +The map is available for five HEALPix levels (6 through 10), published +here as separate tables, map6 through map10. A union of the coverage is +provided as map_union. Use its coverage column to match against other +tables. + +See http://argonaut.rc.fas.harvard.edu/ for more details.prdust.map6 The HEALPix map for order 6 (nside=64); the pixel scale is about 55'. + +In ADQL, all array indices are 1-based.74healpixThe healpix (of order 6) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map7 The HEALPix map for order 7 (nside=128); the pixel scale is about +27'. + +In ADQL, all array indices are 1-based.410healpixThe healpix (of order 7) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map8 The HEALPix map for order 8 (nside=256); the pixel scale is about +14'. + +In ADQL, all array indices are 1-based.192156healpixThe healpix (of order 8) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map9 The HEALPix map for order 9 (nside=512); the pixel scale is about +6.9'. + +In ADQL, all array indices are 1-based.1100000healpixThe healpix (of order 9) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map10 The HEALPix map for order 10 (nside=1024); the pixel scale is about +3.4'. + +In ADQL, all array indices are 1-based.2200000healpixThe healpix (of order 10) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map_unionJoined Bayestar17 3D Dust MapThis is a view of the dust maps in the five orders, generated by +splitting the larger pixels from the higher orders into HEALPixes of +order 10. This means, in particular, that the spatial resolution for +all pixels with original_order!=10. Use this for convenient joins to +other tables.healpixThe healpix (in galactic l, b) for which this data applies. This is of the order given in the hpx_order column, and thus it's not usually useful for querying. Query against the coverage column instead.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullablehpx_orderThe HEALPix order healpix is given for. The dust map is not regularly sampled, which is why orders vary over the sky. For querying, it is simpler to look at coverage than at healpix+order.meta.number;pos.healpixshort
raveRAdial Velocity Experiment: RAVE DR5 The RAdial Velocity Experiment (RAVE) contains stellar atmospheric +parameters (effective temperature, surface gravity, overall +metallicity), radial velocities, chemical abundances and distances. +Observations between 2003 and 2013 were used to build the five RAVE +data releases.rave.mainThe RAVE object catalog of radial velocities, surface gravities, and +chemical parameters for about 500000 stars, data release 5. We have +removed almost all fields originating from crossmatches (as this is +intended for use within our TAP service, where users can do the +crossmatches themselves). Also, some obviously buggy columns (e.g., +footprint_flag) were dropped. + +Note that columns with names ending in _k originate from the stellar +parameters pipeline, those with names ending in _c come from the +chemical pipeline. Columns ending in _n_k indicate calibrated values.520629rave_obs_idUnique Identifier for RAVE objects: Observation Date, Fieldname, Fibernumbermeta.id;meta.maincharindexedprimaryraveidMain RAVE identifiermeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablestddev_rvStandard deviation in HRV from 10 resampled spectrakm/sstat.stdev;spect.dopplerVeloc;pos.heliocentricfloatnullablemad_rvMedian absolute deviation in HRV from 10 resampled spectrakm/sstat.fit.residual;spect.dopplerVeloc;pos.heliocentric;stat.medianfloatnullablestddev_teff_kStandard deviation in Teff_K from 10 resampled spectraKstat.stdev;phys.temperature.effectivefloatnullablemad_teff_kMedian absolute deviation in Teff_K from 10 resampled spectraKstat.fit.residual;phys.temperature.effective;stat.medianfloatnullablestddev_logg_kStandard deviation in Teff_K from 10 resampled spectrastat.stdev;phys.gravityfloatnullablemad_logg_kMedian absolute deviation in metallicity from 10 resampled spectrastat.fit.residual;phys.abund.Z;stat.medianfloatnullablestddev_met_kStandard deviation in metallicity from 10 resampled spectrastat.stdev;phys.abund.Zfloatnullablechisq_kχ² of the Stellar Parameter Pipelinestat.fit.chi2floatnullableteff_irEffective temperature from infrared flux methodKphys.temperature.effectivefloatnullablee_teff_irError in the effective temperature from infrared flux methodKstat.error;phys.temperature.effectivefloatnullableir_directInfrared temperature method: IRFM -- Temperature derived from infrared flux method; CTRL -- Temperature computed via color-Teff relations; NO -- No temperature derivation possiblemeta.codecharnullablealpha_cAlpha-enhancement from chemical pipeline (log solar ratio; 'dex')phys.abundfloatnullablefrac_cFraction of spectrum used for calculation of abundancesstat.valuefloatnullableav_schlegelTotal Extinction in V-band from 1998ApJ...500..525Smagphys.absorptionfloatnullablen_gauss_fitNumber of components required for multi-Gaussian distance modulus fit.meta.numbershortnullablegauss_mean_1Gaussian number 1 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_1Gaussian number 1 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_2Gaussian number 2 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_2Gaussian number 2 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_3Gaussian number 3 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_3Gaussian number 3 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablerep_flagTrue if the object was observed multiple timesmeta.code.qualbooleancluster_flagTrue if this was a targeted cluster observationmeta.code.qualbooleanid_tgasTGAS target designationmeta.id.crosslongnullable
rave.dr4The RAVE object catalog, data release 4. + +Note that columns with names ending in _k originate from the stellar +parameters pipeline, those with names ending in _c come from the +chemical pipeline, those with name ending in _sparv come from the +radial velocity pipeline. Names ending in _n_k indicate calibrated +values.482194nameTarget designationmeta.id;meta.maincharindexedprimaryaltnameRAVE target designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablecorrelation_coeffTonry & Davis R correlation coefficientstat.fit.paramfloatnullablepeak_heightHeight of the correlation peak.stat.correlationfloatnullablepeak_widthWidth of the correlation peak.stat.correlationfloatnullableskyhrvMeasured heliocentry radial velocity of the sky.km/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_skyhrvError in the measured heliocentric velocity of the sky.km/sstat.error;spect.dopplerVeloc;obs.field;pos.heliocentricfloatnullabletdccskyTonry & Davis R Sky correlation coefficient.stat.fit.paramfloatnullablecorrection_rvZero point correction applied to the radial velocity solutions (see 2011AJ....141..187S).km/sarith.zpfloatnullablezeropoint_flagQuality flag for Zero point correctionmeta.codecharnullableteff_sparvEffective temperature as determined by the radial velocity pipeline.Kphys.temperature.effectivefloatnullablelogg_sparvLog gravity as determined by the radial velocity pipeline.phys.gravityfloatnullablealpha_sparvMetallicity as determined by the radial velocity pipeline.phys.abund.ZfloatnullableageLogarithm of age (from 2014MNRAS.437..351B)log(a)time.agefloatnullablee_ageError in Age (from 2014MNRAS.437..351B)log(a)stat.error;time.agefloatnullablemassMass (from 2014MNRAS.437..351B)solMassphys.massfloatnullablee_massError Mass (from 2014MNRAS.437..351B)solMassstat.error;phys.massfloatnullable
rave.dr3 +The third data release of RAVE contains spectroscopic radial velocities +for 83072 stars in the Milky-Way southern hemisphere using the 6dF +instrument at the AAO. + +This data collection has been superceded by RAVE data release 4 +(`table rave.dr </__system__/dc_tables/show/tableinfo/rave.main>`_ +in the data center). + +Columns in the data release that resulted from crossmatching were +left out. + +For details, see 2011AJ....141..187S.83072nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (see note)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationyrtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;obs.fieldshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablemetMetallicity [m/H]phys.abund.Fefloatnullablealphaalpha enhancement [{alpha}/Fe]phys.abundfloatnullablechi2Chi square of continuum fitstat.fit.chi2doublenullablesnr2DR2 signal to noise ratiostat.snrfloatnullablesnrPre-flux calibration signal to noisestat.snrfloatnullabletdccTonry-Davis R correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectrum signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag (see note)meta.codecharnullablequalSpectrum quality flag (see note)meta.code.qualcharnullablemaskflagFraction of spectrum unaffected by continuum problems (see note)meta.code.qualfloatnullable
rave.dr2Data Release 2 +The second data release of RAVE contains spectroscopic radial velocities +for 49327 stars in the Milky-Way southern hemisphere using the 6dF +instrument at the AAO. Stellar parameters are published for a set of 21121 +stars belonging to the second year of observation. + +This data collection has been superceded by RAVE data release 3 +(`table rave.dr </__system__/dc_tables/show/tableinfo/rave.dr3>`_ +in the data center). + +The data published here comprises all original RAVE data. Columns +in the data release that resulted from crossmatching were left out. + +For details, see 2008MNRAS.391..793S.51829nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvHRV errorkm/sstat.errorfloatnullablepmraProper motion in RAmas/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAmas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationmas/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationmas/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (0 - no PM; 1 - Tycho-2; 2 - Supercosmos; 3 - STARNET 2.0; 4 - GSC1.2x2MASS; 5 - UCAC-2)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationdtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;instr.paramshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablem_h_uncalUncalibrated [M/H]phys.abund.Fefloatnullablealfa_fealpha enhancement [{alpha}/Fe]phys.abundfloatnullablem_hCalibrated [M/H], Sun=1phys.abund.Fefloatnullablechi2chi squarestat.fit.chi2doublenullablesnrCorrected signal to noisestat.snrfloatnullabletdccTonry-Davis correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectra signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag [dispersion around correction <1 (A), 1..2 (B), 2..3 (C), >3 km/s (D); E - less than 15 fibers available.]meta.codecharnullablezp250 fibers group to which the fiber belongs zero point correction flagmeta.codecharnullablegapwarningFiber is close to a 15 fibers gapmeta.codebooleanqualSpectra quality flag [a - asymmetric Ca lines; c - cosmic ray pollution; e - emission line spectra; n - noise dominated spectra; l - no lines visible; w - weak lines; g - strong ghost; t - bad template fit; s - strong residual sky emission; cc - bad continuum; r - red part of the spectra shows problem; b - blue part of the spectra shows problem; p - possible binary/doubled lined; x - peculiar object;]meta.code.qualcharnullable
rosatROSAT results +ROSAT was an orbiting x-ray observatory active in the 1990s. +We provide a table of all photons observed during ROSAT's all-sky +survey (RASS) as well as images of both survey and pointed observations. + +For ROSAT data products, see +http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-surveyrosat.photonsA table of x-ray photons detected by ROSAT88000000raj2000Right Ascension, equinox 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination, equinox 2000.0degpos.eq.dec;meta.maindoubleindexednullabledetection_timeTime the photon was detected, in Julian years.yrtime.startdoubleindexednullableenergy_corEnergy of incoming photon (corrected) [keV]keVphys.energy;em.X-rayfloatindexednullableposition_errorTotal positional error, 1{sigma} arcsecarcsecstat.error;pos.eqfloatnullableglongGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablepulseht_channelChannel of the pulse height. This is a measure for the energy of the incoming photon, where one channel corresponds to about 10 eV; a pulse height channel of 127 thus indicates an incoming photon of about 1.3 keV.shortnullableexposure_timeROSAT cluster survey exposure timestime.duration;obs.exposurefloatnullablefield_idRASS field idmeta.id;obs.fieldshortnullableixX pixel coordinatepixelpos.cartesian.x;instr.detshortnullableiyY pixel coordinatepixelpos.cartesian.y;instr.detshortnullableidPhoton identifier (a combination of observation date and detector coordinates)meta.id;meta.mainlongindexedprimary
rosat.imagesMetadata for ROSAT pointed observations and the ROSAT All Sky Survey +(RASS) images115678accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableseqnoROR sequence numbermeta.id;obsintindexedfollowupNumber of follow-up observation (0=first observation, NULL=mispointing)meta.code;obsintnullableobstypeType of data in the file (associated products available through datalink of by querying through seqno)meta.code;meta.filecharnullablepubdidPublisher dataset identifier (this lets you access datalink services and the like)meta.idcharnullabledlurlLink to a datalink document for this dataset, this lets you access associate data)meta.ref.urlcharnullable
rrGAVO RegTAP Service +Tables containing the information in the IVOA Registry. To query +these tables, use `our TAP service`_. + +For more information and example queries, see the +`RegTAP specification`_. + +.. _our TAP service: /__system__/tap/run/info +.. _RegTAP specification: http://www.ivoa.net/documents/RegTAP/ivo://ivoa.net/std/RegTAP#1.1rr.registries Administrative table: publishing registries we harvest, together with +the dates of last full and incremental harvests.ivo://ivoa.net/std/RegTAP#1.153ivoidIVOID of the registry.charindexedprimaryaccessurlURL of the registry's OAI-PMH endpoint.charnullabletitleName of the registry.unicodeCharnullablelast_full_harvestDate and time of the last full harvest of the registry.charnullablelast_inc_harvestDate and time of the last incremental harvest of the registry.charnullable
rr.authorities A mapping between the registries and the authorities they claim to +manage.ivo://ivoa.net/std/RegTAP#1.1142ivoidIVOID of the registry.charnullablemanaged_authorityAn authority this registry claims to serve.charindexedprimaryrr.registriesivoidivoid
rr.resource The resources (like services, data collections, organizations) +present in this registry.xpath:/24138ivoidUnambiguous reference to the resource conforming to the IVOA standard for identifiers.xpath:identifiercharindexedprimaryres_typeResource type (something like vg:authority, vs:catalogservice, etc).xpath:@xsi:typecharnullablecreatedThe UTC date and time this resource metadata description was created.xpath:@createdcharnullableshort_nameA short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).xpath:shortNamecharindexednullableres_titleThe full name given to the resource.xpath:titleunicodeCharindexednullableupdatedThe UTC date this resource metadata description was last updated.xpath:@updatedcharnullablecontent_levelA hash-separated list of content levels specifying the intended audience.xpath:content/contentLevelcharnullableres_descriptionAn account of the nature of the resource.xpath:content/descriptionunicodeCharindexednullablereference_urlURL pointing to a human-readable document describing this resource.xpath:content/referenceURLcharnullablecreator_seqThe creator(s) of the resource in the order given by the resource record author, separated by semicolons.xpath:curation/creator/nameunicodeCharindexednullablecontent_typeA hash-separated list of natures or genres of the content of the resource.xpath:content/typecharnullablesource_formatThe format of source_value. This, in particular, can be ``bibcode''.xpath:content/source/@formatcharnullablesource_valueA bibliographic reference from which the present resource is derived or extracted.xpath:content/sourceunicodeCharnullableres_versionLabel associated with creation or availablilty of a version of a resource.xpath:curation/versioncharnullableregion_of_regardA single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.degxpath:coverage/regionOfRegardfloatnullablewavebandA hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.xpath:coverage/wavebandcharnullablerightsA statement of usage conditions (license, attribution, embargo, etc).xpath:/rightscharnullablerights_uriA URI identifying a license the data is made available under.xpath:/rights/@rightsURIcharnullableharvested_fromIVOID of the registry this record came from.charnullablerr.registriesharvested_fromivoid
rr.res_role Entities (persons or organizations) operating on resources: creators, +contacts, publishers, contributors.ivo://ivoa.net/std/RegTAP#1.195827ivoidThe parent resource.xpath:/identifiercharindexednullablerole_nameThe real-world name or title of a person or organization.unicodeCharindexednullablerole_ivoidAn IVOA identifier of a person or organization.charnullablestreet_addressA mailing address for a person or organization.unicodeCharnullableemailAn email address the entity can be reached at.charnullabletelephoneA telephone number the entity can be reached at.charnullablelogoURL pointing to a graphical logo, which may be used to help identify the entity.charnullablebase_roleThe role played by this entity; this is one of contact, publisher, contributor, or creator.charindexednullablerr.resourceivoidivoid
rr.res_subject Topics, object types, or other descriptive keywords about the +resource.xpath:/content/55057ivoidThe parent resource.xpath:/identifiercharindexednullableres_subjectTopics, object types, or other descriptive keywords about the resource.xpath:subjectcharindexednullablerr.resourceivoidivoid
rr.subject_uat res_subject mapped to the UAT. This is based on a manual mapping of +keywords found in 2020, where subjects not mappable were dropped. This +is a non-standard, local extension. Don't base your procedures on it, +we will tear it down once there is sufficient takeup of the UAT in the +VO.ivo://ivoa.net/std/RegTAP#1.151571ivoidThe parent resource.xpath:/identifiercharindexednullableuat_conceptTerm from http://www.ivoa.net/rdf/uat; most of these resulted from mapping non-UAT designations.charindexednullablerr.resourceivoidivoid
rr.capability Pieces of behaviour of a resource.xpath:/capability/95817ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexAn arbitrary identifier of this capability within the resource.shortindexedprimarycap_typeThe type of capability covered here. If looking for endpoints implementing a certain standard, you should not use this column but rather match against standard_id.xpath:@xsi:typecharnullablecap_descriptionA human-readable description of what this capability provides as part of the over-all service.xpath:descriptionunicodeCharnullablestandard_idA URI for a standard this capability conforms to.xpath:@standardIDcharnullablerr.resourceivoidivoid
rr.res_schema Sets of tables related to resources.xpath:/tableset/schema/2137ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexAn arbitrary identifier for the res_schema rows belonging to a resource.shortindexedprimaryschema_descriptionA free text description of the tableset explaining in general how all of the tables are related.xpath:descriptionunicodeCharnullableschema_nameA name for the set of tables.xpath:name charnullableschema_titleA descriptive, human-interpretable name for the table set.xpath:titleunicodeCharnullableschema_utypeAn identifier for a concept in a data model that the data in this schema as a whole represent.xpath:utypecharnullablerr.resourceivoidivoid
rr.res_table (Relational) tables that are part of schemata or resources.xpath:/(tableset/schema/|)table/60176ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexIndex of the schema this table belongs to, if it belongs to a schema (otherwise NULL).shortnullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharnullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharnullabletable_indexAn arbitrary identifier for the tables belonging to a resource.shortindexedprimarytable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharnullabletable_typeA name for the role this table plays. Recognized values include "output", indicating this table is output from a query; "base_table", indicating a table whose records represent the main subjects of its schema; and "view", indicating that the table represents a useful combination or subset of other tables. Other values are allowed.xpath:@typecharnullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullablenrowsAn estimate for the number of rows in the table.xpath:nrowslongnullablerr.resourceivoidivoid
rr.table_column Metadata on columns of a resource's tables.xpath:/(tableset/schema/|)/table/column/1300000ivoidThe parent resource.xpath:/identifiercharindexednullabletable_indexIndex of the table this column belongs to.shortnameThe name of the column.xpath:namecharindexednullableucdA unified content descriptor that describes the scientific content of the column.xpath:ucdcharindexednullableunitThe unit associated with all values in the column.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this column represents.xpath:utypecharnullablestdIf 1, the meaning and use of this column is reserved and defined by a standard model. If 0, it represents a database-specific column that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the column.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this column contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullabletype_systemThe type system used, as a QName with a canonical prefix; this will ususally be one of vs:simpledatatype, vs:votabletype, and vs:taptype.xpath:dataType/@xsi:typecharnullableflagHash-separated keywords representing traits of the column. Recognized values include "indexed", "primary", and "nullable".xpath:flagcharnullablecolumn_descriptionA free-text description of the column's contents.xpath:descriptionunicodeCharindexednullablerr.res_tableivoidivoidtable_indextable_index
rr.g_num_stat An experimental table containing advanced statistics for numeric +table columns. This is only available for very few tables at this +point. + +Note that the values reported here may be estimates based on a subeset +of the table rows.ivo://ivoa.net/std/RegTAP#1.11052ivoidThe parent resource.xpath:/identifiercharnullabletable_indexIndex of the table this column belongs to.shortnameName of the column (see rr.table_column for more metadata).charindexednullablefill_factorAn estimate for the ratio of non-NULL values in this column to the number of rows in the table.floatnullablemin_valueThe largest value found in the column.floatnullablepercentile03An estimate for the value in the 3rd percentile of the column's distribution (for a Gaussian, roughly the lower limit of a 2σ interval).floatindexednullablemedianAn estimate for the median value (or 50th percentile) of the column's distributionfloatindexednullablepercentile97An estimate for the value in the 97th percentile of the column's distribution (for a Gaussian, roughly the upper limit of a 2σ interval).floatindexednullablemax_valueThe largest value found in the column.floatnullablerr.res_tableivoidivoidtable_indextable_index
rr.res_detail XPath-value pairs for members of resource or capability and their +derivations that are less used and/or from VOResource extensions. The +pairs refer to a resource if cap_index is NULL, to the referenced +capability otherwise.ivo://ivoa.net/std/RegTAP#1.1215590ivoidThe parent resource.xpath:/identifiercharindexednullablecap_indexThe index of the parent capability; if NULL the xpath-value pair describes a member of the entire resource.shortnullabledetail_xpathThe xpath of the data item.charnullabledetail_value(Atomic) value of the member.unicodeCharnullablerr.resourceivoidivoid
rr.interface Information on access modes of a capability.xpath:/capability/interface/95935ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexThe index of the parent capability.shortindexedintf_indexAn arbitrary identifier for the interfaces of a resource.shortindexedprimaryintf_typeThe type of the interface (vr:webbrowser, vs:paramhttp, etc).xpath:@xsi:typecharnullableintf_roleAn identifier for the role the interface plays in the particular capability. If the value is equal to "std" or begins with "std:", then the interface refers to a standard interface defined by the standard referred to by the capability's standardID attribute.xpath:@rolecharnullablestd_versionThe version of a standard interface specification that this interface complies with. When the interface is provided in the context of a Capability element, then the standard being refered to is the one identified by the Capability's standardID element.xpath:@versioncharnullablequery_typeHash-joined list of expected HTTP method (get or post) supported by the service.xpath:queryTypecharnullableresult_typeThe MIME type of a document returned in the HTTP response.xpath:resultTypecharnullablewsdl_urlThe location of the WSDL that describes this Web Service. If NULL, the location can be assumed to be the accessURL with '?wsdl' appended.xpath:wsdlURLcharnullableurl_useA flag indicating whether this should be interpreted as a base URL ('base'), a full URL ('full'), or a URL to a directory that will produce a listing of files ('dir').xpath:accessURL/@usecharnullableaccess_urlThe URL at which the interface is found.xpath:accessURLcharnullablemirror_urlSecondary access URLs of this interface, separated by hash characters.xpath:mirrorURLcharnullableauthenticated_onlyA flag for whether an interface is available for anonymous use (=0) or only authenticated clients are served (=1).shortsecurity_method_idThis column was mentioned in drafts of RegTAP 1.1 but was abandoned before RegTAP 1.1 REC. Do not use any more. This is just here to avoid a flag day for clients that experimentally used this column. This is always NULL here.not mappedcharnullablerr.capabilityivoidivoidcap_indexcap_index
rr.relationship Relationships between resources (like mirroring, derivation, serving +a data collection).xpath:/content/relationship/23702ivoidThe parent resource.xpath:/identifiercharindexednullablerelationship_typeThe type of the relationship; these terms are drawn from a controlled vocabulary and are DataCite-compatible.xpath:relationshipTypecharnullablerelated_idThe IVOA identifier for the resource referred to.xpath:relatedResource/@ivo-idcharnullablerelated_nameThe name of resource that this resource is related to.xpath:relatedResourcecharnullablerr.resourceivoidivoid
rr.intf_param Input parameters for services.xpath:/capability/interface/param/3178ivoidThe parent resource.xpath:/identifiercharindexednullableintf_indexThe index of the interface this parameter belongs to.shortnameThe name of the parameter.xpath:namecharnullableucdA unified content descriptor that describes the scientific content of the parameter.xpath:ucdcharnullableunitThe unit associated with all values in the parameter.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this parameter represents.xpath:utypecharnullablestdIf 1, the meaning and use of this parameter is reserved and defined by a standard model. If 0, it represents a database-specific parameter that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the parameter.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this parameter contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullableparam_useAn indication of whether this parameter is required to be provided for the application or service to work properly (one of required, optional, ignored, or NULL).xpath:@usecharnullableparam_descriptionA free-text description of the parameter's contents.xpath:descriptionunicodeCharnullablerr.interfaceivoidivoidintf_indexintf_index
rr.validationValidation levels for resources and capabilities.xpath:/(capability/|)validationLevel23685ivoidThe parent resource.xpath:/identifiercharindexednullablevalidated_byThe IVOA ID of the registry or organisation that assigned the validation level.xpath:validationLevel/@validatedBycharnullableval_levelA numeric grade describing the quality of the resource description, when applicable, to be used to indicate the confidence an end-user can put in the resource as part of a VO application or research study.xpath:validationLevelshortnullablecap_indexIf non-NULL, the validation only refers to the capability referenced here.shortnullablerr.resourceivoidivoidrr.resourceivoidivoid
rr.res_date A date associated with an event in the life cycle of the resource. +This could be creation or update. The role column can be used to +clarify.xpath:/curation/23363ivoidThe parent resource.xpath:/identifiercharindexednullabledate_valueA date associated with an event in the life cycle of the resource.xpath:datecharnullablevalue_roleA string indicating what the date refers to, e.g., created, availability, updated. This value is generally drawn from a controlled vocabulary.xpath:date/@rolecharnullablerr.resourceivoidivoid
rr.alt_identifier An alternate identifier associated with this record. This can be a +resiource identifier like a DOI (in URI form, e.g., +doi:10.1016/j.epsl.2011.11.037), or a person identifier of a creator +(typically an ORCID in URI form, e.g., orcid:000-0000-0000-000X).xpath:/(curation/creator/|)altIdentifier63ivoidThe parent resource.xpath:/identifiercharindexednullablealt_identifierAn identifier for the resource or an entity related to the resource in URI form.charindexednullablerr.resourceivoidivoid
rr.stc_spatial The spatial coverage of resources. This table associates footprints +(ADQL geometries) with ivoids. The footprints are intended for +resource discovery; a reasonable expectation for the resolution thus +is something like a degree.xpath:/coverage/spatial16828ivoidThe parent resource.xpath:/identifiercharindexednullablecoverageA geometry representing the area a resource contains data for; this should be tight at least with a resolution of degrees.posxpath:.charnullableref_system_nameThe reference frame coverage is written in. This is currently reserved and fixed to NULL. Clients should always add a constraint to NULL for this to avoid matching non-celestial resources later.pos.framexpath:@framecharnullablerr.resourceivoidivoid
rr.stc_temporal The temporal coverage of resources, given as one or more intervals. +The total coverage is (a subset of) the union of all intervals given +for a resource. All times are understood as MJD for TDB at the solar +system barycenter.xpath:/coverage/temporal104ivoidThe parent resource.xpath:/identifiercharindexednullabletime_startLower limit of a time interval covered by the resource.dxpath:.floattime_endUpper limit of a time interval covered by the resource.dxpath:.floatrr.resourceivoidivoid
rr.stc_spectral The spectral coverage of resources, given as one or more intervals. +The total coverage is (a subset of) the union of all intervals given +for a resource. The spectral values are given as messenger energy.xpath:/coverage/spectral89ivoidThe parent resource.xpath:/identifiercharindexednullablespectral_startLower limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatspectral_endUpper limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatrr.resourceivoidivoid
rr.tap_table TAP-queriable tables.ivo://ivoa.net/std/RegTAP#1.1residIVOA identifier of the resource this table was taken from (where there is a dedicated resource containing this table in its tableset, that resource is preferred over a TAP service).charindexednullablesvcidIVOA identifier of the TAP service making this table queriable.charindexednullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharindexednullabletable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharindexednullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharindexednullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullable
sasmiralaSasmirala: Subarcsecond mid-infrared atlas of local AGN The Subarcsecond mid-infrared (MIR) atlas of local active galactic +nuclei (AGN) is a collection of all available N- and Q-band images +obtained at ground-based 8-meter class telescopes with public archives +(Gemini/Michelle, Gemini/T-ReCS, Subaru/COMICS, and VLT/VISIR). It +includes in total 895 images, of which 60% are perviously unpublished. +These correspond to 253 local AGN with a median redshift of 0.016. The +atlas contains the uniformly processed and calibrated images and +nuclear photometry obtained through Gauss and PSF fitting for all +objects and filters. This also includes measurements of the nuclear +extensions. In addition, the classifications of extended emission (if +present) and derived nuclear monochromatic 12 and 18 micron continuum +fluxes are available. Finally, flux ratios with the circumnuclear MIR +emission (measured by Spitzer) and total MIR emission of the galaxy +(measured by IRAS) are presented.sasmirala.objectsSasmirala Basic Object PropertiesBasic object properties and nuclear 12 and 18 micron continuum +fluxes/ratios.253nameCommon object namemeta.id;meta.maincharindexedprimaryraj2000Right Ascension J2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000.0degpos.eq.dec;meta.maindoubleindexednullableprodlinkLink to a web page with images, bibliography, and other details on the source.charnullablezRedshiftsrc.redshiftfloatnullabledDistanceMpcfloatnullableclsOptical classification (References for the collected optical AGN classifications are given in App. B of 2014MNRAS.439.1648A)src.classcharnullableu_agnClassification as AGN uncertain?meta.codebooleanbatidBAT ID from 9-month catalog (from Winter et al, 2009, 2009ApJ...690.1322W)meta.idintnullablen_extNuclear morphology at subarcsecond resolutionmeta.code;src.morphcharnullablelim12True if 12 µm flux was not detected. flu12 is a 3-sigma upper level in this case.meta.code;phot.fluxbooleanflu12Nuclear subarcsecond-scale monochromatic flux density at restframe 12 µmmJyphot.flux.density;em.IRfloatnullableerr121-σ uncertainty of the 12 µm continuum fluxmJystat.error;phot.flux;em.IRfloatnullablelim18True if 18 µm flux was not detected. flu18 is a 3-sigma upper level in this case.meta.code;phot.fluxbooleanflu18Nuclear subarcsecond-scale monochromatic flux density at restframe 18 µmmJyphot.flux.density;em.IRfloatnullableerr181-σ uncertainty of the 18 µm continuum fluxmJystat.error;phot.flux;em.IRfloatnullablephotparLink to detailed information on the photometry sources.meta.ref;photchardunrSize constraint on the nuclear unresolved emission in pc, which is set equal to the minimum PSF FWHM (major axis) measured for the objectpcphys.size;srcfloatnullablermedFlux ratio of nuclear to intermediate scale; the in Spitzer/IRS unresolved flux component is used as measure for the intermediate-scale emission.phot.flux;arith.ratiofloatnullablerlarFlux ratio of nuclear to large scale; the IRAS 12 µm flux is used as measure for the large-scale emission.phot.flux;arith.ratiofloatnullablepathcompInterally usedcharnullable
sasmirala.photparPhotometric parameters for all nuclear measurements.901nameCommon object namemeta.id;meta.maincharnullableraj2000Right Ascension J2000.0degpos.eq.ra;meta.maindoublenullabledej2000Declination J2000.0degpos.eq.dec;meta.maindoublenullablefilterFilter namemeta.id;instr.filtercharnullableaccrefAccess key for the datameta.ref.urlAccess.ReferencecharnullableprodlinkLink to a web page with images, bibliography, and other details on the source.charnullablew_obsFilter central wavelength (observing frame)umem.wl.central;instr.filterfloatnullablehwidthFilter half-width-half-maximumuminstr.bandwidthfloatnullableinstrInstrument used to obtain the datameta.id;instrcharnullablepfovPixel size of field of viewarcsec/pixphys.angSize;instr.pixelfloatnullableexptimeTotal exposure time on-sourcestime.duration;obs.exposurefloatnullablemodeChop and nod modeinstr.setupcharnullablecthrowChop throwarcsecinstr.paramfloatnullablecangleChop angledeginstr.paramfloatnullablerotaInstrument rotation angle, west of north.deginstr.param;pos.posAngfloatnullableproidObservation program IDmeta.id;obscharnullablecalnameCalibrator star namemeta.id;obs.calibcharnullablecalmjdMJD of observation of calibrator stardtime.epoch;obs.calibfloatnullabledateobsMJD of observationdtime.epoch;obsdoublenullableconvfConversion factor measured from the CalibrationmJy/ctphot.calibfloatnullableeconvf1-sigma uncertainty of the Conversion factormJy/ctstat.error;phot.calibfloatnullablecalfluCalibrator star fluxmJyphot.flux;obs.calibfloatnullablelimgaussIf True, the object was not detected using Gauss fitting or no matching calibrator star was available. In that case, F_Gauss represents a 3-sigma upper limit.meta.codebooleanfgaussNuclear flux measured through Gauss fittingmJyphot.flux;em.IRfloatnullableefgauss1-sigma uncertainty in nuclear flux measured through Gauss fittingmJystat.error;phot.flux;em.IRfloatnullablelimpsfIf True, the object was not detected using PSF fitting or no matching calibrator star was available. In that case, F_PSF represents a 3-sigma upper limit.meta.codebooleanfpsfNuclear flux measured through PSF fittingmJyphot.flux;em.IRfloatnullableefpsf1-sigma uncertainty in nuclear flux measured through PSF fittingmJystat.error;phot.flux;em.IRfloatnullablecalfmaCalibrator Star major axis FWHMarcsecphys.angSize;obs.calibfloatnullablecalfmiCalibrator Star minor axis FWHMarcsecphys.angSize;obs.calibfloatnullablecalpaCalibrator Star position angle, north over eastdegpos.posAng;obs.calibfloatnullablefwhmmaMajor axis FWHM (constrained to <=1arcsec) of the Gaussian fit of the target objectarcsecphys.angSize;srcfloatnullablefwhmmiMinor axis FWHM (constrained to <=1arcsec) of the Gaussian fit of the target objectarcsecphys.angSize;srcfloatnullablepaPosition Angle, north over east, of the Gaussian fit of the target objectdegpos.posAng;srcfloatnullable
sdssdr16SDSS DR16 Selection This is a redacted version of the SDSS DR16 table prepared for VizieR +(V/154/sdss16). It is mainly here to facilitate local matches; for +original SDSS-related research, it is probably better to somewhere +else. + +Over VizieR and SDSS, we are keeping most of the per-band values in +arrays to keep the column list manageable. Note that in ADQL, array +indexes are 1-based. + +We are trying to orient our column names on SDSS but use underscores +instead of camel-casing (e.g. spec_obj_id instead of SpecObjID), since +mixed-case identifiers in SQL is asking for trouble. + +To save space, we do not keep psf-based classifications, per-band +offsets, spectrum metadata, and USNO-related information in this +table. Let the operators know if you need any of that.sdssdr16.main This is a redacted version of the SDSS DR16 table prepared for VizieR +(V/154/sdss16). It is mainly here to facilitate local matches; for +original SDSS-related research, it is probably better to somewhere +else. + +Over VizieR and SDSS, we are keeping most of the per-band values in +arrays to keep the column list manageable. Note that in ADQL, array +indexes are 1-based. + +We are trying to orient our column names on SDSS but use underscores +instead of camel-casing (e.g. spec_obj_id instead of SpecObjID), since +mixed-case identifiers in SQL is asking for trouble. + +To save space, we do not keep psf-based classifications, per-band +offsets, spectrum metadata, and USNO-related information in this +table. Let the operators know if you need any of that.1300000000obj_idSDSS unique object identifiermeta.id;meta.mainlongindexedprimaryraRight Ascension of the object (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledecDeclination of the object (ICRS)degpos.eq.dec;meta.maindoubleindexednullablera_errMean error on raarcsecstat.error;pos.eq.rafloatnullabledec_errMean error on decarcsecstat.error;pos.eq.decfloatnullablepm_raProper motion along Right Ascensionmas/yrpos.pm;pos.eq.rafloatnullablee_pm_raMean error on pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepm_decProper motion along Declinationmas/yrpos.pm;pos.eq.decfloatnullablepm_dec_errMean error on pmDE.mas/yrstat.error;pos.pm;pos.eq.decfloatnullablepm_sig_raRMS residual of proper motion fit in RA.masstat.fit.residualfloatnullablepm_sig_decRMS residual of proper motion fit in Dec.masstat.fit.residualfloatnullableuModel magnitude in u filter AB scalemagphot.mag;em.opt.Ufloatnullableerr_uModel magnitude in u filter AB scalemagphot.mag;em.opt.UfloatnullablegModel magnitude in g filter AB scalemagphot.mag;em.opt.Vfloatnullableerr_gModel magnitude in g filter AB scalemagphot.mag;em.opt.VfloatnullablerModel magnitude in r filter AB scalemagphot.mag;em.opt.Rfloatnullableerr_rModel magnitude in r filter AB scalemagphot.mag;em.opt.RfloatnullableiModel magnitude in i filter AB scalemagphot.mag;em.opt.Ifloatnullableerr_iModel magnitude in i filter AB scalemagphot.mag;em.opt.IfloatnullablezModel magnitude in z filter AB scalemagphot.mag;em.opt.Ifloatnullableerr_zModel magnitude in z filter AB scalemagphot.mag;em.opt.Ifloatnullablefield_idThe field this object is in.meta.notelongmodePhoto mode (1=primary, 2=secondary, 3=family, 4=outside)meta.code.classshortclassType of object (3=galaxy, 6=star)src.classshortindexedcleanClean photometry flag (1=clean; 0=unclean)meta.codeshortphoto_flagsPhoto Object Attribute flagsmeta.code.errorlongpsfmagsArray of PSF magnitudes, in ugriz sequencemagphot.magfloatnullablepsfmag_errsArray of the errors of the PSF magnitudes, in ubriz sequencemagstat.error;phot.magfloatnullablepetmagsArray of Petrosian magnitudes, in ugriz sequencemagphot.magfloatnullablepetmag_errsArray of the errors Petrosian magnitudes, in ugriz sequencemagphot.magfloatnullablepetradsArray of Petrosian radii, in ugriz sequencearcsecphys.angSize;srcfloatnullablepetrad_errsArray of Petrosian radii, in ugriz sequencearcsecstat.error;phys.angSize;srcfloatnullabledev_radsArray of de Vaucouleurs fit radii, in ugriz sequencearcsecphys.angSize;srcfloatnullabledev_absArray of de Vaucouleurs fit b/a ratios, in ugriz sequencephys.size.axisRatiofloatnullabledev_phiArray of position angles of de Vaucouleurs fits in ugriz sequence (warning: anything smaller than 0 in here must be considered NULL).degpos.posAngfloatnullableflagsArray of detection flags, in ugriz sequencemeta.codelongnullabletypesArray of phototypes (6=Star ; 3=galaxy) in ugriz sequencesrc.class.starGalaxyshortnullableparent_idPointer to parent (if object deblended)meta.id.parentlongnullablespec_zSpectroscopic final redshift (when SpObjID>0)src.redshiftfloatindexednullablespec_z_errMean error on spec_z (negative for bad fit)stat.errorfloatnullablespec_z_warningWarning flag on redshift.meta.codeshortnullablespec_classSpectroscopic class: "GALAXY"; "QSO"; "STAR"meta.code.class;pos.parallax.spectcharnullablespec_sub_classSpectroscopic subclass.src.classcharnullablespec_vel_dispVelocity dispersionkm/sphys.veloc.dispersionfloatnullablespec_vel_disp_errMean error on spec_vel_dispkm/sstat.errorfloatnullablespec_sn_medianMedian signal-to-noise over all good pixels.em.wl.central;stat.medianfloatnullablephotoz_zPhotometric redshift estimated by robust fit to nearest neighbors in a reference setsrc.redshiftfloatindexednullablephotoz_z_errEstimated error of the photometric redshiftstat.errorfloatnullablephotoz_nn_avg_zAverage redshift of the nearest neighbors; if significantly different from photoz_z this might be a better estimate than photoz_zsrc.redshift.photfloatnullablephotoz_chisqChi-square value for the minimum chi-square template fitstat.valuefloatnullablefield_qualityQuality of the observation: 1=bad; 2=barely acceptable; 3=goodmeta.code.qual;obs.param;obsshortfield_mjdsArray of dates of observation per ugriz banddtime.epochdoublenullablesdss_idSDSS object identifier (run-rerun-camcol-field-object)meta.idcharnullablespectral_idSpectroscopic Plate-MJD-Fiber identifier (plate-mjd-fiberID)meta.idcharnullable
sdssdr7SDSS DR7 PhotoObjAll +This is the result of the query:: + + select + objID, field.run, field.rerun, field.camcol, field.fieldId, + obj, ra, dec, raErr, decErr, raDecCorr, + offsetRa_u, offsetRa_g, offsetRa_r, offsetRa_i, offsetRa_z, + offsetDec_u, offsetDec_g, offsetDec_r, offsetDec_i, offsetDec_z, + u, g, r, i, z, err_u, err_g, err_r, err_i, err_z, + mjd_u, mjd_g, mjd_r, mjd_i, mjd_z + from + PhotoObjAll + join + field + on (field.fieldId=PhotoObjAll.fieldId) + +on SDSS DR7, kindly provided by the Potsdam mirror. All angular +quantities are given in degrees here.sdssdr7.sources +This is the result of the query:: + + select + objID, field.run, field.rerun, field.camcol, field.fieldId, + obj, ra, dec, raErr, decErr, raDecCorr, + offsetRa_u, offsetRa_g, offsetRa_r, offsetRa_i, offsetRa_z, + offsetDec_u, offsetDec_g, offsetDec_r, offsetDec_i, offsetDec_z, + u, g, r, i, z, err_u, err_g, err_r, err_i, err_z, + mjd_u, mjd_g, mjd_r, mjd_i, mjd_z + from + PhotoObjAll + join + field + on (field.fieldId=PhotoObjAll.fieldId) + +on SDSS DR7, kindly provided by the Potsdam mirror. All angular +quantities are given in degrees here.590000000objidUnique SDSS identifier composed from [skyVersion,rerun,run,camcol,field,obj].meta.id;meta.mainlongrunRun numbermeta.id;obsshortrerunRerun numbermeta.id;obsshortcamcolCamera columnmeta.id;instrshortfieldidField numbermeta.id;obs.fieldlongobjThe object id within a field. Usually changes between reruns of the same field.meta.idshortraJ2000 right ascension (r')degpos.eq.ra;meta.maindoubleindexednullabledecJ2000 declination (r')degpos.eq.dec;meta.maindoubleindexednullableraerrError in RAdegstat.error;pos.eq.ra;meta.mainfloatnullabledecerrError in Decdegstat.error;pos.eq.dec;meta.mainfloatnullableradeccorrRA/dec correlationstat.correlation;pos.eq.ra;pos.eq.decfloatnullableoffsetra_uFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_uFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullableuMagnitude in u band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Ufloatnullableerr_uError in corresponding magnitudemagstat.error;phot.mag;em.opt.Ufloatnullableepoch_uDate of observation in u bandyrtime.epochfloatnullableoffsetra_gFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_gFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullablegMagnitude in g band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Vfloatnullableerr_gError in corresponding magnitudemagstat.error;phot.mag;em.opt.Vfloatnullableepoch_gDate of observation in g bandyrtime.epochfloatnullableoffsetra_rFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_rFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullablerMagnitude in r band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Rfloatnullableerr_rError in corresponding magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableepoch_rDate of observation in r bandyrtime.epochfloatnullableoffsetra_iFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_iFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullableiMagnitude in i band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Ifloatnullableerr_iError in corresponding magnitudemagstat.error;phot.mag;em.opt.Ifloatnullableepoch_iDate of observation in i bandyrtime.epochfloatnullableoffsetra_zFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_zFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullablezMagnitude in z band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Ifloatnullableerr_zError in corresponding magnitudemagstat.error;phot.mag;em.opt.Ifloatnullableepoch_zDate of observation in z bandyrtime.epochfloatnullable
smakcedA Near-infrared Census of the Multicomponent Stellar Structure of +Early-type Dwarf Galaxies in the Virgo Cluster +The Stellar content, MAss and Kinematics of Cluster Early-type Dwarf +galaxies (SMAKCED_) project is a survey of 121 Virgo cluster early type +galaxies. This service publishes deep near-infrared (H band) images +obtained by SMAKCED together with `resulting decompositions`_ and other +properties of the galaxies in the sample. + +.. _SMAKCED: http://smakced.net +.. _resulting decompositions: http://smakced.net/data.htmlsmakced.mainSMAKCED infrared images and derived properties of early-type dwarf +galaxies in the Virgo cluster.119accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsApproximate observation date (essentially, month and year should be about right). NULL for archival materialdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableobjectCommon name of the observed galaxy.meta.id;meta.maincharraj2000ICRS RA of galaxy center from asymmetry centering (unless specified otherwise in remarks).degpos.eq.ra;meta.maindoublenullabledej2000ICRS Declination of galaxy center from asymmetry centering (unless specified otherwise in remarks).degpos.eq.dec;meta.maindoublenullableexptimeTotal integration time for the object (sum of exposure times of all images stacked; note that different telescopes were in use).stime.duration;obs.exposurefloatnullableseeingEstimate for the seeing at observation time.arcsecinstr.obsty.seeingfloatnullablesnrSignal to noise ratio for a pixel at 2 r_e.stat.snrfloatnullablehmagTotal H-band magnitude of the galaxyphot.mag;em.ir.Hfloatnullabler_eEffective radius of the galaxy (semi-major axis of half-light aperture in H).arcsecphys.angSizefloatnullableb_aAxis raio at 2 r_ephys.angSize;arith.ratiofloatnullableconcentrationConcentration index 5 log_80/r_20 as in 2000AJ....119.2645Bphys.size;arith.ratiofloatnullablerho10Local projected number density of cluster galaxies. (see Appendix D in the source)log(deg**-2)src.densityfloatnullableremarksMorphological features from 2006AJ....132.2432L and other remarksmeta.notecharnullablemoreinfoBibcodes of papers containing more information.meta.refcharnullablestructgroupStructural Group (see 2012ApJ...745L..24J) resulting from the decomposition.meta.code.classcharnullablesimp_mIntegrated H-band brightness, simple modelmagphot.mag;em.ir.Hfloatnullablesimp_rcHalf-light radius, simple modelarcsecphys.angSize;srcfloatnullablesimp_nSérsic index, simple modelstat.fit.paramfloatnullablesimp_b_aAxis ratio, simple modelphys.angSize;arith.ratiofloatnullableinner_mIntegrated H-band brightness, inner componentmagphot.mag;em.ir.Hfloatnullableinner_rcHalf-light radius, inner componentarcsecphys.angSize;srcfloatnullableinner_nSérsic index, inner componentstat.fit.paramfloatnullableinner_b_aAxis ratio, inner componentphys.angSize;arith.ratiofloatnullableouter_mIntegrated H-band brightness, global/outer componentmagphot.mag;em.ir.Hfloatnullableouter_rcHalf-light radius, global/outer componentarcsecphys.angSize;srcfloatnullableouter_nSérsic index, global/outer componentstat.fit.paramfloatnullableouter_b_aAxis ratio, global/outer componentphys.angSize;arith.ratiofloatnullablesimpdec_rffResidual flux fraction (2006ApJ...644...30B) for the single decompositionstat.fit.goodnessfloatnullablesimpdec_eviExcess variance index (2011MNRAS.411.2439H) for single decompositionstat.fit.goodnessfloatnullablefinaldec_rffResidual flux fraction (2006ApJ...644...30B) for the final decompositionstat.fit.goodnessfloatnullablefinaldec_eviExcess variance index (2011MNRAS.411.2439H) for final decompositionstat.fit.goodnessfloatnullablecompmorphAdditional information on decomposition.meta.note;src.morphcharnullable
speciesAtomic and Molecular Species Names A TAP-queriable database of common names of molecules and their +InChIs. This is an experimental copy of http://species.vamdc.org +created in the context of the LineTAP effort, augmented with names +found in the CASA line list. You will probably want to query this +using SQL wildcards (% and _) and the ILIKE operator.species.main A TAP-queriable database of common names of molecules and their +InChIs. This is an experimental copy of http://species.vamdc.org +created in the context of the LineTAP effort, augmented with names +found in the CASA line list. You will probably want to query this +using SQL wildcards (% and _) and the ILIKE operator.ivo://ivoa.net/std/linetap#species-1.0inchikeyInChIKey of this speciescharindexednullableinchiInChI of this speciescharnullablenameA common name of this speciesunicodeCharindexednullableformulaChemical formula of this speciescharindexednullablestoichiometricformulaChemical formula of this speciescharnullablesource_idVAMDC identifier of the origin of this mappingcharnullable
spm4Yale/San Juan SPM4 Catalog The SPM4 Catalog contains absolute proper motions, celestial +coordinates, and B,V photometry for 103,319,647 stars and galaxies +between the south celestial pole and -20 degrees declination. The +catalog is roughly complete to V=17.5. It is based on photographic and +CCD observations taken with the Yale Southern Observatory's +double-astrograph at Cesco Observatory in El Leoncito, Argentina.spm4.main The SPM4 Catalog contains absolute proper motions, celestial +coordinates, and B,V photometry for 103,319,647 stars and galaxies +between the south celestial pole and -20 degrees declination. The +catalog is roughly complete to V=17.5. It is based on photographic and +CCD observations taken with the Yale Southern Observatory's +double-astrograph at Cesco Observatory in El Leoncito, Argentina.110000000spmidUnique SPM4 id (field number + input catalog line number)meta.id;meta.maincharindexednullableraj2000Right Ascension (ICRS, epoch=2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (ICRS, epoch=2000.0)degpos.eq.dec;meta.maindoubleindexednullablee_raj2000Expected uncertainty in Right Ascension at mean epochdegstat.error;pos.eq.ra;meta.mainfloatnullablee_dej2000Expected uncertainty in Declination at mean epochdegstat.error;pos.eq.dec;meta.mainfloatnullablepmraAbsolute proper motion in RA (mu_alpha*cos(Dec))deg/yrpos.pm;pos.eq.rafloatnullablepmdeAbsolute proper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmraExpected uncertainty in proper motion in RA (mu_alpha*cos(Dec)), at mean epochdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeExpected uncertainty in proper motion in Declination, at mean epoch.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablemagbB magnitudemagphot.mag;em.opt.BfloatnullablemagvV magnitudemagphot.mag;em.opt.Vfloatindexednullablei_magbsource flag for B magnitudemeta.code;phot.mag;em.opt.Bchari_magvsource flag for V magnitudemeta.code;phot.mag;em.opt.VcharmeanepWeighted mean epochyrtime.epochfloatnullableep1Weighted mean epoch of first observationyrtime.epochfloatnullableep2Weighted mean epoch of second observationyrtime.epochfloatnullablenplates1Number of 1st epoch plates usedmeta.number;instr.plateshortnplates2Number of 2nd epoch plates usedmeta.number;instr.plateshortnccd2Number of 2nd epoch ccd frames usedmeta.numbershorti_galGalaxy/extended-source flagsrc.class.starGalaxyshorti_catCode for the input catalogmeta.codeshortmagjJ selected default magnitude from 2MASSmagphot.mag;em.IR.JfloatnullablemaghH selected default magnitude from 2MASSmagphot.mag;em.IR.HfloatnullablemagkK_s selected default magnitude from 2MASSmagphot.mag;em.IR.Kfloatnullable
supercosmosSuperCOSMOS Sources The SuperCOSMOS data primarily originate from scans of the UK Schmidt +and Palomar POSS II blue, red and near-IR sky surveys. The ESO Schmidt +R (dec < -17.5) and Palomar POSS-I E (dec > -17.5) surveys have also +been scanned and provide an early (1st) epoch red measurement. +Mirrored here is the source table containing four-plate multi-colour, +multi-epoch data which are merged into a single source catalogue for +general science exploitation. Within the GAVO DC, some column names +have been adapted to local customs (primarily positions, proper +motions).supercosmos.sources The SuperCOSMOS data primarily originate from scans of the UK Schmidt +and Palomar POSS II blue, red and near-IR sky surveys. The ESO Schmidt +R (dec < -17.5) and Palomar POSS-I E (dec > -17.5) surveys have also +been scanned and provide an early (1st) epoch red measurement. +Mirrored here is the source table containing four-plate multi-colour, +multi-epoch data which are merged into a single source catalogue for +general science exploitation. Within the GAVO DC, some column names +have been adapted to local customs (primarily positions, proper +motions).1900000000objidSuperCOSMOS identifier of merged sourcemeta.id;meta.mainlongobjidbobjID for B band detection merged into this objectmeta.id.assoclongnullableobjidr1objID for R1 band detection merged into this objectmeta.id.assoclongnullableobjidr2objID for R2 band detection merged into this objectmeta.id.assoclongnullableobjidiobjID for I band detection merged into this objectmeta.id.assoclongnullableepochEpoch of position (variance weighted mean epoch of available measures)yrtime.epochfloatnullableraj2000Mean RA, computed from detections merged in this cataloguedegpos.eq.ra;meta.maindoubleindexednullabledej2000Mean Dec, computed from detections merged in this cataloguedegpos.eq.dec;meta.maindoubleindexednullablesigraUncertainty in RA (formal random error not including systematic errors)degstat.error;pos.eq.rafloatnullablesigdecUncertainty in Dec (formal random error not including systematic errors)degstat.error;pos.eq.rafloatnullablepmraProper motion in RA directiondeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Dec directiondeg/yrpos.pm;pos.eq.decfloatnullablee_pmraError on proper motion in RA directiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeError on proper motion in Dec directiondeg/yrstat.error;pos.pm;pos.eq.decfloatnullablechi2Chi-squared value of proper motion solutionstat.fit.chi2floatnullablenplatesNo. of plates used for this proper motion measurementmeta.number;obsshortclassmagbB band magnitude selected by B image classmagphot.mag;em.opt.Bfloatindexednullableclassmagr1R1 band magnitude selected by R1 image classmagphot.mag;em.opt.Rfloatnullableclassmagr2R2 band magnitude selected by R2 image classmagphot.mag;em.opt.RfloatnullableclassmagiI band magnitude selected by I image classmagphot.mag;em.opt.IfloatindexednullablegcormagbB band magnitude assuming object is galaxymagphot.mag;em.opt.Bfloatnullablegcormagr1R1 band magnitude assuming object is galaxymagphot.mag;em.opt.Rfloatnullablegcormagr2R2 band magnitude assuming object is galaxymagphot.mag;em.opt.RfloatnullablegcormagiI band magnitude assuming object is galaxymagphot.mag;em.opt.IfloatnullablescormagbB band magnitude assuming object is starmagphot.mag;em.opt.Bfloatnullablescormagr1R1 band magnitude assuming object is starmagphot.mag;em.opt.Rfloatnullablescormagr2R2 band magnitude assuming object is starmagphot.mag;em.opt.RfloatnullablescormagiI band magnitude assuming object is starmagphot.mag;em.opt.IfloatnullablemeanclassEstimate of image class based on unit-weighted mean of individual classessrc.class.starGalaxyshortclassbImage classification from B band detectionsrc.class;em.opt.Bshortnullableclassr1Image classification from R1 band detectionsrc.class;em.opt.Rshortnullableclassr2Image classification from R2 band detectionsrc.class;em.opt.RshortnullableclassiImage classification from I band detectionsrc.class;em.opt.IshortnullableellipbEllipticity of B band detectionsrc.ellipticityfloatnullableellipr1Ellipticity of R1 band detectionsrc.ellipticity;em.opt.Rfloatnullableellipr2Ellipticity of R2 band detectionsrc.ellipticity;em.opt.RfloatnullableellipiEllipticity of I band detectionsrc.ellipticity;em.opt.IfloatnullablequalbBitwise quality flag from B band detectionmeta.code.qual;em.opt.Bintnullablequalr1Bitwise quality flag from R1 band detectionmeta.code.qual;em.opt.Rintnullablequalr2Bitwise quality flag from R2 band detectionmeta.code.qual;em.opt.RintnullablequaliBitwise quality flag from I band detectionmeta.code.qual;em.opt.IintnullableblendbBlend flag from B band detectionmeta.code.qual;em.opt.Bintnullableblendr1Blend flag from R1 band detectionmeta.code.qual;em.opt.Rintnullableblendr2Blend flag from R2 band detectionmeta.code.qual;em.opt.RintnullableblendiBlend flag from I band detectionmeta.code.qual;em.opt.IintnullableprfstatbProfile statistic from B band detectionsrc.class.starGalaxyfloatnullableprfstatr1Profile statistic from R1 band detectionsrc.class.starGalaxy;em.opt.Rfloatnullableprfstatr2Profile statistic from R2 band detectionsrc.class.starGalaxy;em.opt.RfloatnullableprfstatiProfile statistic from I band detectionsrc.class.starGalaxy;em.opt.RfloatnullableebmvThe estimated foreground reddening at this position from Schlegel et al. (1998)magphys.absorptionfloatnullable
tap_schema GAVO Data Center's Table Access Protocol (TAP) service with +table metadata.tap_schema.schemasSchemas containing tables available for ADQL querying.schema_nameFully qualified schema namecharindexedprimarydescriptionBrief description of the schemaunicodeCharnullableutypeutype if schema corresponds to a data modelcharnullableschema_indexSuggested position this schema should take in a sorted list of schemas from this data center.intnullable
tap_schema.tablesTables available for ADQL querying.schema_nameFully qualified schema namecharnullabletable_nameFully qualified table namecharindexedprimarytable_typeOne of: table, viewcharnullabledescriptionBrief description of the tableunicodeCharnullableutypeutype if the table corresponds to a data modelcharnullabletable_indexSuggested position this table should take in a sorted list of tables from this data centerintnullablesourcerdId of the originating rd (local information)charnullablenrowsThe approximate size of the table in rowslongnullabletap_schema.schemasschema_nameschema_name
tap_schema.columnsColumns in tables available for ADQL querying.table_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columnunicodeCharnullableunitUnit in VO standard formatcharnullableucdUCD of column if anycharnullableutypeUtype of column if anycharnullabledatatypeADQL datatypecharnullablearraysizeArraysize in VOTable notationcharnullablextypeVOTable extended type information (for special interpretation of data content, e.g., timestamps or points)charnullable"size"Legacy length (ignore if you can).intnullableprincipalIs column principal?intindexedIs there an index on this column?intstdIs this a standard column?intsourcerdId of the originating rd (local information)charnullablecolumn_index1-based index of the column in database order.shortnullabletap_schema.tablestable_nametable_name
tap_schema.keysForeign key relationships between tables available for ADQL querying.key_idUnique key identifiercharindexedprimaryfrom_tableFully qualified table namecharnullabletarget_tableFully qualified table namecharnullabledescriptionDescription of this keyunicodeCharnullableutypeUtype of this keycharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablesfrom_tabletable_nametap_schema.tablestarget_tabletable_name
tap_schema.key_columnsColumns participating in foreign key relationships between tables +available for ADQL querying.key_idKey identifier from TAP_SCHEMA.keyscharnullablefrom_columnKey column name in the from tablecharnullabletarget_columnKey column in the target tablecharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.keyskey_idkey_id
tap_schema.groupsColumns that are part of groups within tables available for ADQL +querying.table_nameFully qualified table namecharnullablecolumn_nameName of a column belonging to the groupcharnullablecolumn_utypeutype the column within the groupcharnullablegroup_nameName of the groupcharnullablegroup_utypeutype of the groupcharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablestable_nametable_name
taptestData for regression teststaptest.mainA table containing nonsensical data. Do not use except for +experiments.radegpos.eq.ra;meta.mainfloatindexednullablededegpos.eq.dec;meta.mainfloatindexednullablespectralinstr.bandpasscharnullable
tenpcThe 10 parsec sample in the Gaia era A catalogue of 541 nearby (within 10pc of the sun) stars, brown +dwarfs, and confirmed exoplanets in 336 systems, as well 21 +candidates, compiled from SIMBAD and several other sources. Where +available, astrometry and photometry from Gaia eDR3 has been inserted.tenpc.main A catalogue of 541 nearby (within 10pc of the sun) stars, brown +dwarfs, and confirmed exoplanets in 336 systems, as well 21 +candidates, compiled from SIMBAD and several other sources. Where +available, astrometry and photometry from Gaia eDR3 has been inserted.562nb_objRunning number for object, ordered by increasing distancemeta.id;meta.mainshortnb_sysRunning number for system, ordered by increasing distancemeta.id.parentshortsystem_nameName of the systemmeta.id.parentcharnullableobj_catOne of Star (*), LM (low mass star), BD (brown dwarf), WD (white dwarf), or Planetmeta.code.classcharnullableobj_nameAdopted name of the objectmeta.idcharnullableraRight ascension at epoch (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledecDeclination at epoch (ICRS)degpos.eq.dec;meta.maindoubleindexednullableepochEpoch for ra and decyrtime.epochfloatnullableparallaxTrigonometric parallaxmaspos.parallax.trigdoublenullableparallax_errorParallax uncertaintymasstat.error;pos.parallaxdoublenullableparallax_bibcodeReference for the parallax; missing values here mean the parallax is taken from another member of the systemmeta.bib;pos.parallaxcharnullablepmraProper motion in right ascensionmas/yrpos.pm;pos.eq.radoublenullablepmra_errorProper motion uncertainty in right ascensionmas/yrstat.error;pos.pm;pos.eq.radoublenullablepmdecProper motion in declinationmas/yrpos.pm;pos.eq.decdoublenullablepmdec_errorProper motion uncertainty in declinationmas/yrstat.error;pos.pm;pos.eq.decdoublenullablepm_bibcodeReference for the proper motion; missing values here mean that the proper motion was taken from another member of the systemmeta.ref;pos.pm;pos.eq.racharnullablervLine-of-sight velocitykm/sspect.dopplerVelocfloatnullablerv_errorLine-of-sight velocity uncertaintykm/sstat.error;spect.dopplerVelocfloatnullablerv_bibcodeReference for the line-of-sight velocitymeta.ref;spect.dopplerVeloccharnullablesp_typeSpectral typesrc.sptypecharnullablesp_bibcodeReference for spectral typemeta.ref;src.sptypecharnullablesp_methodMethod used to derive the spectral typemeta.codecharnullableg_codeSource of the value of the G magnitude (see note)meta.code;phot.mag;em.opt.Vshortnullablemag_gGaia G band magnitude measured (when g_code is 2 or 3)magphot.mag;em.opt.Vdoublenullablemag_g_estimateEstimated Gaia G band magnitude (when g_code is not 2 or 3)magphot.mag;em.opt.Vfloatnullablemag_gbpGaia BP band magnitudephot.mag;em.opt.Bdoublenullablemag_grpGaia RP band magnitudephot.mag;em.opt.Rdoublenullablemag_uMagnitude in Umagphot.mag;em.opt.Ufloatnullablemag_bMagnitude in Bmagphot.mag;em.opt.Bfloatnullablemag_vMagnitude in Vmagphot.mag;em.opt.Vfloatnullablemag_rMagnitude in Rmagphot.mag;em.opt.Rfloatnullablemag_iMagnitude in Imagphot.mag;em.opt.Ifloatnullablemag_jMagnitude in Jmagphot.mag;em.ir.Jfloatnullablemag_hMagnitude in Hmagphot.mag;em.ir.Hfloatnullablemag_kMagnitude in Kmagphot.mag;em.ir.Kfloatnullablesystem_bibcodeReference for multiplicity or exoplanetsmeta.refcharnullableexoplanet_countNumber of confirmed exoplanetsmeta.numbershortnullablegaia_dr2Gaia DR2 identifiermeta.id.crosslongnullablegaia_edr3Gaia EDR3 identifiermeta.id.crosslongnullablesimbad_nameName resolved by SIMBADmeta.id.crosscharnullablecommon_nameCommon namemeta.idcharnullablegjGliese and Jahreiß catalogue identifiermeta.id.crosscharnullablehdHenry Draper catalogue identifiermeta.id.crosscharnullablehipHipparcos catalogue identifiermeta.id.crosscharnullablecommentAdditional comments on exoplanets, multiplicity, etcmeta.notecharnullable
tgasTGAS catalogue This table is a subset of GaiaSource comprising those stars in the +Hipparcos and Tycho-2 Catalogues for which a full 5-parameter +astrometric solution has been possible in Gaia Data Release 1. This is +possible because the early Hipparcos epoch positions break some +degeneracies due to the limited Gaia time coverage. This table +contains a substantial fraction of the around 2.5 million stars in the +Hipparcos and Tycho-2 catalogue. Many stars have been excluded due to +several reasons, such as saturation, cross-match errors or bad +astrometric solution. All rows have Gaia solution id +1635378410781933568.tgas.main This table is a subset of GaiaSource comprising those stars in the +Hipparcos and Tycho-2 Catalogues for which a full 5-parameter +astrometric solution has been possible in Gaia Data Release 1. This is +possible because the early Hipparcos epoch positions break some +degeneracies due to the limited Gaia time coverage. This table +contains a substantial fraction of the around 2.5 million stars in the +Hipparcos and Tycho-2 catalogue. Many stars have been excluded due to +several reasons, such as saturation, cross-match errors or bad +astrometric solution. All rows have Gaia solution id +1635378410781933568.2100000source_idUnique source identifiermeta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablelGalactic longitude (converted from ra, dec)degpos.galactic.londoublenullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoublenullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.radoublenullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decdoublenullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epochmaspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullableref_epochReference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_qHipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noiseExcess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sigSignificance of excess noisestat.valuefloatnullableastrometric_n_obs_acTotal number of observations ACmeta.numbershortastrometric_n_obs_alTotal number of observations ALmeta.numbershortastrometric_n_bad_obs_acNumber of bad observations ACmeta.numbershortastrometric_n_bad_obs_alNumber of bad observations ALmeta.numbershortastrometric_n_good_obs_acNumber of good observations ACmeta.numbershortastrometric_n_good_obs_alNumber of good observations ALmeta.numbershortastrometric_primary_flagOnly primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortmatched_observationsThe number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_usedType of prior used in in the astrometric solutionshortnullableastrometric_relegation_factorRelegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_acMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_alMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_sourceDuring data processing, this source happened to been duplicated and one source only has been kept.shortra_dec_corrCorrelation between right ascension and declinationstat.correlationfloatnullablera_pmra_corrCorrelation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corrCorrelation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corrCorrelation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corrCorrelation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corrCorrelation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corrCorrelation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corrCorrelation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corrCorrelation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corrCorrelation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4Degree of concentration of scan directions across the sourcefloatnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelonghipHipparcos identifierintnullabletycho2_idTycho 2 identifiercharnullable
theossaTheoSSA - Theoretical Stellar Spectra AccessTheoSSA provides spectral energy distributions based on model +atmosphere calculations. Currently, we serve results obtained using +the Tübingen NLTE Model Atmosphere Package (TMAP) for hot compact +stars.theossa.dataTheoSSA metadata in the SSAP schema.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablet_effEffective temperature assumedKphys.temperature.effectivefloatnullablelog_gLog of surface gravity assumedcm/s**2phys.gravityfloatnullablemdotMass loss ratesolMass/yrphys.mass.lossfloatnullablew_hMass fraction of H in the model computed.phys.abundfloatnullablew_heMass fraction of He in the model computed.phys.abundfloatnullablew_liMass fraction of Li in the model computed.phys.abundfloatnullablew_beMass fraction of Be in the model computed.phys.abundfloatnullablew_bMass fraction of B in the model computed.phys.abundfloatnullablew_cMass fraction of C in the model computed.phys.abundfloatnullablew_nMass fraction of N in the model computed.phys.abundfloatnullablew_oMass fraction of O in the model computed.phys.abundfloatnullablew_fMass fraction of F in the model computed.phys.abundfloatnullablew_neMass fraction of Ne in the model computed.phys.abundfloatnullablew_naMass fraction of Na in the model computed.phys.abundfloatnullablew_mgMass fraction of Mg in the model computed.phys.abundfloatnullablew_alMass fraction of Al in the model computed.phys.abundfloatnullablew_siMass fraction of Si in the model computed.phys.abundfloatnullablew_pMass fraction of P in the model computed.phys.abundfloatnullablew_sMass fraction of S in the model computed.phys.abundfloatnullablew_clMass fraction of Cl in the model computed.phys.abundfloatnullablew_arMass fraction of Ar in the model computed.phys.abundfloatnullablew_kMass fraction of K in the model computed.phys.abundfloatnullablew_caMass fraction of Ca in the model computed.phys.abundfloatnullablew_scMass fraction of Sc in the model computed.phys.abundfloatnullablew_tiMass fraction of Ti in the model computed.phys.abundfloatnullablew_vMass fraction of V in the model computed.phys.abundfloatnullablew_crMass fraction of Cr in the model computed.phys.abundfloatnullablew_mnMass fraction of Mn in the model computed.phys.abundfloatnullablew_feMass fraction of Fe in the model computed.phys.abundfloatnullablew_coMass fraction of Co in the model computed.phys.abundfloatnullablew_niMass fraction of Ni in the model computed.phys.abundfloatnullablew_znMass fraction of Zn in the model computed.phys.abundfloatnullablew_gaMass fraction of Ga in the model computed.phys.abundfloatnullablew_geMass fraction of Ge in the model computed.phys.abundfloatnullablew_krMass fraction of Kr in the model computed.phys.abundfloatnullablew_moMass fraction of Mo in the model computed.phys.abundfloatnullablew_tcMass fraction of Tc in the model computed.phys.abundfloatnullablew_snMass fraction of Sn in the model computed.phys.abundfloatnullablew_xeMass fraction of Xe in the model computed.phys.abundfloatnullablew_baMass fraction of Ba in the model computed.phys.abundfloatnullable
tossTOSS -- Tübingen Oscillator Strengths Service This service provides oscillator strengths and transition +probabilities. Mainly based on experimental energy levels, these were +calculated with the pseudo-relativistic Hartree-Fock method including +core-polarization corrections.toss.dataA table of transitions, their species, and their properties.930656wavelengthWavelength of the transition.mem.wlssldm:Line.wavelength.valuedoubleindexedlinenameTerse descriptor of the linemeta.id;em.linessldm:Line.titlecharchemical_elementElement transitioningphys.atmol.elementssldm:Line.species.namecharindexednullableinitial_nameName of the level the atom or molecule starts in.phys.atmol.initial;phys.atmol.levelssldm:Line.initialLevel.namecharnullablefinal_nameName of the level the atom or molecule ends up in.phys.atmol.final;phys.atmol.levelssldm:Line.finalLevel.namecharnullableinitial_level_energyEnergy of the level the atom or molecule starts in.Jphys.energy;phys.atmol.initial;phys.atmol.leveldoublenullablefinal_level_energyEnergy of the level the atom or molecule ends up in.Jphys.energy;phys.atmol.final;phys.atmol.leveldoublenullablepubThe publication this value originated from.meta.bibcharnullableid_statusIdentification status of the linemeta.codecharnullableion_stageIonisation stagephys.atmol.ionStagecharindexednullablec_wavelengthConventional wavelength of the transition. This is the air wavelength between 2000 and 20000 Angstrom, the vacuum wavelength otherwise.Angstromem.wl;phys.atmol.transitiondoubleindexednullablepar_initParity of the init level of the transitionphys.atmol.paritycharj_initAngular momentum quantum number of the init level of the transition.phys.atmol.qnfloatnullablepar_finalParity of the final level of the transitionphys.atmol.paritycharj_finalAngular momentum quantum number of the final level of the transition.phys.atmol.qnfloatnullablelog_gfCalculated HRF log(gf) (g -- statistical weight of the lower level; f -- oscillator strength)phys.atmol.wOscStrengthfloatnullablegaTransition probability times the statistical weight of the upper level1e9s**-1phys.atmol.transProbfloatnullablecfCancellation factor as defined by 1981tass.book.....Cfloatnullable
toss.line_tap This is a prototype for a future LineTAP specification. If you are +not interested in validating LineTAP, you should probably not use this +table.ivo://ivoa.net/std/linetap#table-1.0titleHuman-readable line designation.meta.idcharindexedvacuum_wavelengthVacuum wavelength of the transitionAngstromem.wldoubleindexedvacuum_wavelength_errorTotal error in vacuum_wavelengthAngstromstat.error;em.wldoublenullablemethodMethod the wavelength was obtained with (XSAMS controlled vocabulary)meta.code.classcharnullableelementElement name for atomic transitions, NULL otherwise.phys.atmol.elementcharindexednullableion_chargeTotal charge (ionisation level) of the emitting particle.phys.electChargeintindexedmass_numberNumber of nucleons in the atom or moleculephys.atmol.weightintnullableupper_energyEnergy of the upper stateJphys.energy;phys.atmol.initialdoublenullablelower_energyEnergy of the lower stateJphys.energy;phys.atmol.finaldoublenullableinchiInternational Chemical Identifier InChI.meta.id;phys.atmol;meta.maincharinchikeyThe InChi key (hash) generated from inchi.meta.id;phys.atmolchareinstein_aEinstein A coefficient of the radiative transition.phys.atmol.transProbdoublenullablexsams_uriA URI for a full XSAMS description of this line.meta.refcharnullableline_referenceReference to the source of the line data; this could be a bibcode, a DOI, or a plain URI.meta.refcharnullable
twomassThe 2MASS point source catalogThe 2MASS Point Source Catalogue, short a couple of exotic fields. We +provide this data mainly for matching with other catalogs within our +TAP service.twomass.dataThe 2MASS Point Source Catalogue, short a couple of exotic fields. We +provide this data mainly for matching with other catalogs within our +TAP service.480000000raj2000Right ascension (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000)degpos.eq.dec;meta.maindoubleindexednullableerrmajMajor axis of position error ellipsedegstat.error;pos.eqfloatnullableerrminMinor axis of position error ellipsedegstat.error;pos.eqfloatnullableerrpaPosition angle of error ellipse major axis (E of N)degstat.error;pos.eqfloatnullablemainidSource designationmeta.id;meta.maincharindexedprimaryjmag2MASS J magnitudemagphot.mag;em.IR.JfloatindexednullablejcmsigJ default magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.JfloatnullablejsnrJ Signal-to-noise ratiostat.snr;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.HfloatindexednullablehcmsigH default magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.HfloatnullablehsnrH Signal-to-noise ratiostat.snr;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatindexednullablekcmsigmagnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.KfloatnullableksnrK Signal-to-noise ratiostat.snr;phot.mag;em.IR.KfloatnullableqflgJHK photometric quality flagmeta.code.qual;photcharnullablerflgJHK default magnitude read flagmeta.refcharnullablebflgJHK blend flagmeta.codecharnullablecflgContamination and confusion flagmeta.codecharnullablexflgExtended source contaminationmeta.codecharnullableaflgAssociation with asteroid or cometmeta.codecharnullablepts_keyUnique source identifier in cataloguemeta.id;meta.tablelongindexed"date"Observation dateyrtime.epoch;obscharnullablescanScan number (within date)meta.id;obs.fieldshortxscanDistance of source from focal plane centerlinedegpos.distance;pos.cartesian;instr.detfloatnullablejdJulian date of detectiondtime.epochcharnullableedgensDistance from the source to the nearest North or South scan edgedegpos;arith.difffloatnullableedgeewDistance from the source to the nearest East or West scan edgedegpos;arith.difffloatnullableedgeflag indicating to which edges the edgeNS and edgeEW values refermeta.code;pos.cartesian;instr.detcharnullabledupFlag indicating duplicate sourcemeta.codecharnullableuse_srcUse source flagmeta.codecharnullable
ucac3UCAC3 nocrossThe Third US Naval Observatory CCD Astrograph catalogue (UCAC3) is an +all-sky catalgoue containing just over 100 million objects covering +about R = 8-16 mag. This table contains the original data content of +UCAC3 but leaves out the data objetained by crossmatching to other +catalogs.ucac3.mainThe UCAC3 all-sky CCD astrograph catalogue, minus the fields from +2MASS and SuperCosmos and matching/object flags (which can be +recovered with a local crossmatch).110000000raj2000Right ascension at epoch (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at epoch (ICRS)degpos.eq.dec;meta.maindoubleindexednullablemmagUCAC fit model magnitudemagphot.mag;em.optfloatnullablemaperUCAC aperture magnitudemagphot.mag;em.optfloatnullablesigmagUCAC error on magnitude (larger of obs. scatter and model error)magstat.error;phot.mag;em.optfloatnullableobjtObject typesrc.classcharnullabledsfDouble star flagmeta.codecharnullablesigras.e. at central epoch in RA (*cos Dec)degstat.error;pos.eq.rafloatnullablesigdcs.e. at central epoch in Decdegstat.error;pos.eq.decfloatnullablena1Total number of CCD images of this starmeta.numbershortnu1Number of CCD images used for this starmeta.number;stat.fitshortus1Number of catalogs/epochs used for proper motionsmeta.numbershortcn1Number of catalogs/epochs in initial matchmeta.numbershortcepraCentral epoch for mean RAtime.epochcharnullablecepdcCentral epoch for mean Declinationtime.epochcharnullablepmraProper motion in RA, cos(Dec) applieddeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablesigpmraError in proper motion in RA, cos(Dec) applieddeg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
ucac3.ppmxlcrossA crossmatch between UCAC3 and PPMXL, created solely based on +positions with a window of 1.5 arcsec radius.99000000ucac3idipix of UCAC3 objectmeta.idlongindexedppmxlidPPMXL ipixmeta.id;meta.mainlongindexed
ucac3.icrscorrCorrections between UCAC3 and the ICRS as represented by PPMXL on a +grid of degrees, obtained by substracting UCAC3 from PPMXL in cones of +radius sqrt(2)/2 degrees around the given center position.65294nobNumber of objects the correction is based onmeta.numberintalphaCenter for field, RAdegpos.eq.ra;meta.mainfloatindexednullabledeltaCenter for field, Decdegpos.eq.dec;meta.mainfloatindexednullabled_alphaCorrection PPMXL-UCAC3 in alpha (Epoch 2000.0)degpos.eq.ra;arith.difffloatnullabled_deltaCorrection PPMXL-UCAC3 in delta (Epoch 2000.0)degpos.eq.dec;arith.difffloatnullabled_pmalphaCorrection PPMXL-UCAC3 in proper motion alpha*cos(delta)deg/yrpos.pm;pos.eq.ra;arith.difffloatnullabled_pmdeltaCorrection PPMXL-UCAC3 in deltadeg/yrpos.pm;pos.eq.dec;arith.difffloatnullable
ucac4The fourth U.S. Naval Observatory CCD Astrograph Catalog (UCAC4) UCAC4 is a compiled, all-sky star catalog covering mainly the 8 to 16 +magnitude range in a single bandpass between V and R. +Positional errors are about 15 to 20 mas for stars in the 10 to 14 mag +range. Proper motions have been derived for most of the about 113 +million stars utilizing about 140 other star catalogs with significant +epoch difference to the UCAC CCD observations. These data are +supplemented by 2MASS photometric data for about 110 million stars and +5-band (B,V,g,r,i) photometry from the APASS (AAVSO Photometric +All-Sky Survey) for over 50 million stars. UCAC4 also contains error +estimates and various flags. All bright stars not observed with +the astrograph have been added to UCAC4 from a set of Hipparcos and +Tycho-2 stars. Thus UCAC4 should be complete from the brightest stars +to about R=16, with the source of data indicated in flags.ucac4.main UCAC4 is a compiled, all-sky star catalog covering mainly the 8 to 16 +magnitude range in a single bandpass between V and R. +Positional errors are about 15 to 20 mas for stars in the 10 to 14 mag +range. Proper motions have been derived for most of the about 113 +million stars utilizing about 140 other star catalogs with significant +epoch difference to the UCAC CCD observations. These data are +supplemented by 2MASS photometric data for about 110 million stars and +5-band (B,V,g,r,i) photometry from the APASS (AAVSO Photometric +All-Sky Survey) for over 50 million stars. UCAC4 also contains error +estimates and various flags. All bright stars not observed with +the astrograph have been added to UCAC4 from a set of Hipparcos and +Tycho-2 stars. Thus UCAC4 should be complete from the brightest stars +to about R=16, with the source of data indicated in flags.120000000ucacidUCAC 2 identification number (UCAC4-zzz-nnnnnn)meta.id;meta.maincharindexednullableraj2000Right Ascension at epoch J2000.0 (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at epoch J2000.0 (ICRS)degpos.eq.dec;meta.maindoubleindexednullablemagmUCAC fit model magnitudemagphot.mag;em.opt.VfloatnullablemagaUCAC aperture magnitudemagphot.mag;em.opt.Vfloatindexednullablesigmagerror of UCAC magnitudemagstat.error;phot.mag;em.opt.VfloatnullableobjtObject typesrc.classshortcdfCombined double star flagmeta.code.multipshortsigraStandard error at central epoch in RA (*cos Dec)degstat.error;pos.eq.rafloatnullablesigdecStandard error at central epoch in Decdegstat.error;pos.eq.decfloatnullablena1Total number of CCD images of this starmeta.numbershortnu1Number of CCD images used for this starmeta.numbershortcu1Number of catalogs (epochs) used for proper motionsmeta.numbershortcepraCentral epoch for mean RAyrtime.epochfloatnullablecepdecCentral epoch for mean Decyrtime.epochfloatnullablepmraProper motion in RA*cos(Dec)deg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Decdeg/yrpos.pm;pos.eq.decfloatnullablesigpmrStandard error of proper motion in RA*cos(Dec)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdStandard error of proper motion in Decdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepts_key2MASS unique star identifiermeta.idintnullablemagj2MASS J magnitudemagphot.mag;em.IR.JfloatnullablesigmagjError in 2MASS J magnitudemagstat.error;phot.mag;em.IR.JfloatnullableicqflgjQuality flag for 2MASS J magnitudemagmeta.code;phot.mag;em.IR.Jshortnullablemagh2MASS H magnitudemagphot.mag;em.IR.HfloatnullablesigmaghError in 2MASS H magnitudemagstat.error;phot.mag;em.IR.HfloatnullableicqflghQuality flag for 2MASS H magnitudemagmeta.code;phot.mag;em.IR.Hshortnullablemagk_s2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablesigmagk_sError in 2MASS K_s magnitudemagstat.error;phot.mag;em.IR.Kfloatnullableicqflgk_sQuality flag for 2MASS K_s magnitudemagmeta.code;phot.mag;em.IR.KshortnullablemagbB magnitude from APASSmagphot.mag;em.opt.BfloatnullablesigmagbError in B magnitude from APASSmagstat.error;phot.mag;em.opt.BfloatnullablemagvV magnitude from APASSmagphot.mag;em.opt.VfloatnullablesigmagvError in V magnitude from APASSmagstat.error;phot.mag;em.opt.Vfloatnullablemaggg magnitude from APASSmagphot.mag;em.opt.VfloatnullablesigmaggError in g magnitude from APASSmagstat.error;phot.mag;em.opt.Vfloatnullablemagrr magnitude from APASSmagphot.mag;em.opt.RfloatnullablesigmagrError in r magnitude from APASSmagstat.error;phot.mag;em.opt.Rfloatnullablemagii magnitude from APASSmagphot.mag;em.opt.IfloatnullablesigmagiError in i magnitude from APASSmagstat.error;phot.mag;em.opt.IfloatnullablespmflagsYale SPM g and c flagsmeta.code;srcshortnullablesrcflagsSource flags (see note)meta.codeintnullablediam2massObject size from 2MASSdegphys.angSize;srcfloatnullablernmUnique star identification numbermeta.idintzn2Zone number of UCAC2meta.id.partshortnullablern2Running record number along UCAC2 zonemeta.idintnullable
ucac5The fifth U.S. Naval Observatory CCD Astrograph Catalog (UCAC5) New astrometric reductions of the US Naval Observatory CCD Astrograph +Catalog (UCAC) all-sky observations were performed from first +principles using the TGAS stars in the 8 to 11 magnitude range as +reference star catalog. Significant improvements in the astrometric +solutions were obtained and the UCAC5 catalog of mean positions at a +mean epoch near 2001 was generated. By combining UCAC5 with Gaia DR1 +data new proper motions on the Gaia coordinate system for over 107 +million stars were obtained with typical accuracies of 1 to 2 mas/yr +(R = 11 to 15 mag), and about 5 mas/yr at 16th mag. Proper motions of +most TGAS stars are improved over their Gaia data and the precision +level of TGAS proper motions is extended to many millions more, +fainter stars. + +The database table uses actual NULLs for missing photometry, and all +angular coordinates have been homogenised to degrees.ucac5.main New astrometric reductions of the US Naval Observatory CCD Astrograph +Catalog (UCAC) all-sky observations were performed from first +principles using the TGAS stars in the 8 to 11 magnitude range as +reference star catalog. Significant improvements in the astrometric +solutions were obtained and the UCAC5 catalog of mean positions at a +mean epoch near 2001 was generated. By combining UCAC5 with Gaia DR1 +data new proper motions on the Gaia coordinate system for over 107 +million stars were obtained with typical accuracies of 1 to 2 mas/yr +(R = 11 to 15 mag), and about 5 mas/yr at 16th mag. Proper motions of +most TGAS stars are improved over their Gaia data and the precision +level of TGAS proper motions is extended to many millions more, +fainter stars. + +The database table uses actual NULLs for missing photometry, and all +angular coordinates have been homogenised to degrees.110000000source_idGaia source IDmeta.id;meta.mainlongraGaia DR1 Right Ascension at epoch J2015.0degpos.eq.ra;meta.maindoubleindexednullabledecGaia DR1 Declination at epoch J2015.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied); from Gaia DR1.degstat.error;pos.eq.rafloatnullabledec_errorStandard error of dec; from Gaia DR1.degstat.error;pos.eq.decfloatnullablesrcflagsSource for the star: 1 = TGAS, 2 = other UCAC-Gaia star, 3 = other NOMADmeta.codeshortnu1Number of images used for UCAC mean positionmeta.numbershortepuMean UCAC epoch (i.e. epoch for ra_ucac and de_ucac)yrtime.epochfloatnullablera_ucacMean UCAC RA at epoch epu on Gaia reference framedegpos.eq.radoublenullablede_ucacmean UCAC Dec at epoch epu on Gaia reference framedegpos.eq.decdoublenullablepmraPM(RA), cos(δ) applied, computed from UCAC and Gaia DR1 positions.deg/yrpos.pm;pos.eq.rafloatnullablepmdePM(Dec), computed from UCAC positions and Gaia DR1 positions.deg/yrpos.pm;pos.eq.decfloatnullablesigpmrStandard error of proper motion in RA*cos(Dec)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdStandard error of proper motion in Decdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablegmagGaia DR1 G magnitudemagphot.mag;em.optfloatnullableumagMean UCAC model magnitude (20 in the source is mapped to NULL)magphot.mag;em.opt.VfloatnullablermagNOMAD photographic R mag (0 and 30 in the source are mapped to NULL)magphot.mag;em.opt.Rfloatnullablejmag2MASS J magnitude (0 and 30 in the source are mapped to NULL)magphot.mag;em.IR.Jfloatnullablehmag2MASS H magnitude (0 and 30 in the source are mapped to NULL)magphot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitude (0 and 30 in the source are mapped to NULL)magphot.mag;em.IR.Kfloatnullable
urat1The first U.S. Naval Observatory Astrometric Robotic Telescope Catalog +URAT1 star catalog +URAT1 is an observational catalog at a mean epoch between 2012.3 and +2014.6; ot covers the magnitude range 3 to 18.5 in R-band, with a +positional precision of 5 to 40 mas. It covers most of the northern +hemisphere and some areas down to -24.8° in declination. + +In the GAVO data center, we left out all columns originating from +cross matches with other catalogs; on-the fly crossmatches can be done +in our TAP service.urat1.main +URAT1 is an observational catalog at a mean epoch between 2012.3 and +2014.6; ot covers the magnitude range 3 to 18.5 in R-band, with a +positional precision of 5 to 40 mas. It covers most of the northern +hemisphere and some areas down to -24.8° in declination. + +In the GAVO data center, we left out all columns originating from +cross matches with other catalogs; on-the fly crossmatches can be done +in our TAP service.230000000idURAT1 recommended identifier (ZZZ-NNNNNN)meta.id;meta.maincharindexedprimaryraj2000Right ascension on ICRS, at Epochdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination on ICRS, at Epochdegpos.eq.dec;meta.maindoubleindexednullablepos_err_scatterPosition error per coordinate, from scatterdegstat.error;posfloatnullablepos_err_modelPosition error per coordinate, from modeldegstat.error;posfloatnullableepochMean URAT observation epochyrtime.epochfloatnullablemagMean URAT model fit magnitude (between R and I)magphot.mag;em.opt.Rfloatindexednullablee_magError in URAT model fit magnitude, derived from the scatter of individual observations, plus a floor of 0.01.magstat.error;phot.mag;em.opt.Rfloatnullablen_setsTotal number of images (observations)meta.number;obsshortn_sets_posNumber of sets used for mean positionmeta.number;obsshortn_sets_magNumber of sets used for URAT magnitudemeta.number;obsshortrefstarLargest reference star flagmeta.code.qualcharn_imTotal number of images (observations)meta.number;obsshortn_im_usedNumber of images used for mean positionmeta.number;obsshortn_gratingTotal number of 1st order grating observationsmeta.number;obsshortn_grating_usedNumber of 1st order grating positions usedmeta.number;obsshort
usnobPlate data for the USNO-B 1.0 Catalogue. This table contains the metadata for the plates that went into USNO-B +1.0 as best as we can reconstruct it (i.e., largely those that also +make up the Digital Sky Survey DSS). Most of the source files were +obtained from http://www.nofs.navy.mil/data/fchpix/, some additional +contributions came from Dave Monet.usnob.dataThe USNO-B 1.0 catalogue with Barron's spurious detections removed.1100000000raj2000Right Ascension at Eq=J2000, Ep=J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at Eq=J2000, Ep=J2000degpos.eq.dec;meta.maindoubleindexednullablee_radegMean error on RAdeg*cos(DEdeg) at Epochdegstat.error;pos.eq.rafloatnullablee_dedegMean error on DEdeg at Epochdegstat.error;pos.eq.decfloatnullableepochMean epoch of observationyrtime.epochfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in DEdeg/yrpos.pm;pos.eq.decfloatnullablemuprTotal Proper Motion probabilitystat.fit.goodnessfloatnullablee_pmraMean error on pmRAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error on pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablefit_raMean error on RA fitdegstat.errorfloatnullablefit_deMean error on DE fitdegstat.errorfloatnullablendetNumber of detectionsmeta.numbershortflagsFlags on objectmeta.codecharnullableb1magFirst blue magnitude (B1)magphot.mag;em.opt.Bfloatnullableb1sB1 Survey codemeta.idcharindexednullableb1fB1 Field number in surveymeta.id;obs.fieldshortindexednullableb1sgB1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb1xiB1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb1etaB1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler1magFirst red magnitude (R1)magphot.mag;em.opt.Rfloatnullabler1sR1 Survey codemeta.idcharindexednullabler1fR1 Field number in surveymeta.id;obs.fieldshortindexednullabler1sgR1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler1xiR1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler1etaR1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableb2magSecond blue magnitude (B2)magphot.mag;em.opt.Bfloatnullableb2sB2 Survey codemeta.idcharindexednullableb2fB2 Field number in surveymeta.id;obs.fieldshortindexednullableb2sgB2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb2xiB2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb2etaB2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler2magSecond red magnitude (R2)magphot.mag;em.opt.Rfloatnullabler2sR2 Survey codemeta.idcharindexednullabler2fR2 Field number in surveymeta.id;obs.fieldshortindexednullabler2sgR2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler2xiR2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler2etaR2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableimagInfrared (N) magnitudemagphot.mag;em.opt.Ifloatnullablei_sI Survey codemeta.idcharindexednullableifI Field number in surveymeta.id;obs.fieldshortindexednullableisgI Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableixiI Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableietaI Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullable
usnob.spuriousSpurious detections in USNO-B 1.0 as established by Barron et al, +2008AJ....135..414B.18000000raRA of spurious detectiondegpos.eq.ra;meta.maindoubleindexednullabledecDec of spurious detectiondegpos.eq.dec;meta.maindoubleindexednullable
usnob.ppmxcrossA crossmatch between USNO-B 1.0 and PPMX.18000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedppmxidPPMX id of matching objectmeta.id;meta.maincharindexednullable
usnob.twomasscrossA crossmatch between USNO-B 1.0 and 2MASS.360000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedtwomassid2MASS id of matching objectmeta.id;meta.maincharindexednullable
usnob.platecorrsICRS Corrections by USNO-B1 PlatePlate corrections to USNO-B 1.0 based on a crossmatch with PPMX7194surveySurvey identifier, see long docsmeta.idcharfieldField number in surveymeta.id;obs.fieldshortdaMean offset in alphadegpos.eq.ra;arith.difffloatnullableddMean offset in deltadegpos.eq.dec;arith.difffloatnullablentotalNumber of objects in estimatemeta.numberint
usnob.platesPlate data for the source plates of USNO-B8855fieldField number in surveymeta.id;obs.fieldshortplatePlate number in USNO-Bmeta.id;obs.field;meta.maincharnullablesurveySurvey identifier, see long docsmeta.idcharindexedepochPlate epochyrtime.epochcharnullableemulsionEmulsioninstr.plate.emulsioncharnullablefilterFiltermeta.id;instr.filtercharnullableexposureLength of exposurestime.duration;obs.exposurefloatnullableusnocode2-char plate code given in the plate cataloguemeta.id;obs.fieldcharnullablealpha1950Field center alpha for B1950degpos.eq.rafloatnullabledelta1950Field center decl for B1950degpos.eq.decfloatnullablealpha2000Field center alpha for J2000degpos.eq.ra;meta.mainfloatindexednullabledelta2000Field center decl for J2000degpos.eq.dec;meta.mainfloatindexednullablesrcSource file for this recordmeta.ref;meta.filecharnullablealphamin1950degpos.eq.ra;stat.minfloatnullablealphamax1950degpos.eq.ra;stat.maxfloatnullabledeltamin1950degpos.eq.dec;stat.minfloatnullabledeltamax1950degpos.eq.dec;stat.maxfloatnullable
veronqsosQuasars and Active Galactic Nuclei (8th Ed.) This catalogue (with updates to the pervious version) contains 11358 +(+2759) quasars (defined as brighter than absolute B magnitude -23), +3334 (+501) AGNs (defined as fainter than absolute B magnitude -23) +and 357 (+137) BL Lac objects from 1863 (+201) references.veronqsos.data This catalogue (with updates to the pervious version) contains 11358 +(+2759) quasars (defined as brighter than absolute B magnitude -23), +3334 (+501) AGNs (defined as fainter than absolute B magnitude -23) +and 357 (+137) BL Lac objects from 1863 (+201) references.11358notradio'*' if not detected in radiometa.notecharnullablenameMost common name of the objectmeta.idcharnullableraj2000Right Ascension J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000degpos.eq.dec;meta.maindoubleindexednullablen_rahPosition origin: O=optical, R=radio, A=approximativemeta.notecharnullablel_z*=redshift from slitless spectroscopymeta.code.errorcharnullablezRedshiftsrc.redshiftfloatnullablespSpectrum classificationsrc.spTypecharnullablen_vmag'*' for photographic, 'R' for red Vmagmeta.notecharnullablevmagmagnitude, V or other (see n_Vmag)magphot.mag;em.opt.Vfloatnullabler_zReference of the redshiftmeta.refshortnullable
vlastripe82High-Resolution Very Large Array Imaging of Sloan Digital Sky Survey +Stripe 82 at 1.4 GHz +This is a high-resolution radio survey of the Sloan Digital Sky Survey +(SDSS) Southern Equatorial Stripe, a.k.a. Stripe 82. This 1.4 GHz survey +was conducted with the Very Large Array (VLA) primarily in the +A-configuration, with supplemental B-configuration data to increase +sensitivity to extended structure. The survey has an angular resolution +of 1.''8 and achieves a median rms noise of 52 μJy per beam over 92 deg^2. +The catalog contains 17,969 isolated radio components, for an overall +source density of ∼195 sources/deg^2. See also J.A. Hodge et al, +:bibcode:`2011AJ....142....3H` .vlastripe82.stripe82 +This is a high-resolution radio survey of the Sloan Digital Sky Survey +(SDSS) Southern Equatorial Stripe, a.k.a. Stripe 82. This 1.4 GHz survey +was conducted with the Very Large Array (VLA) primarily in the +A-configuration, with supplemental B-configuration data to increase +sensitivity to extended structure. The survey has an angular resolution +of 1.''8 and achieves a median rms noise of 52 μJy per beam over 92 deg^2. +The catalog contains 17,969 isolated radio components, for an overall +source density of ∼195 sources/deg^2. See also J.A. Hodge et al, +:bibcode:`2011AJ....142....3H` .17969raj2000Right Ascension, J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination, J2000degpos.eq.dec;meta.maindoubleindexednullablep_sProbability that the source is spurious (e.g., because of a sidelobe of a nearby bright source).stat.likelihood;obsfloatnullablef_peakPeak flux density derived by fitting an elliptical Gaussian model to the source. The uncertainty is given in the rms_nose column.mJy/beamphot.flux.density;em.radio.1500-3000MHz;stat.maxfloatindexednullablef_intIntegrated flux density in mJy derived from the elliptical Gaussian model fit.mJyphot.flux.density;em.radio.1500-3000MHzfloatnullablerms_noiseLocal noise estimate at the source position, calculated by combining the measured noise from all grid images contributing to the coadded map at the source position.mJystat.error;phot.flux.densityfloatnullablesmaj_axFWHM semimajor axis of the elliptical Gaussian model for the source after beam deconvolution. This is zero when the fitted value prior to deconvolution to is smaller than the beam (1.8'') due to noise.degphys.angSize.smajAxis;meta.modelledfloatnullablesmin_axFWHM semiminor axis of the elliptical Gaussian model for the source after beam deconvolution. This is zero when the fitted value prior to deconvolution to is smaller than the beam due to noise.degphys.angSize.sminAxis;meta.modelledfloatnullablepaPosition angle of the elliptical Gaussian model for the source after beam deconvolution, east of north.degpos.posAng;meta.modelledfloatnullablesmaj_ax_rawFWHM semimajor axis of the elliptical Gaussian model before beam deconvolution.degphys.angSize.smajAxisfloatnullablesmin_ax_rawFWHM semiminor axis of the elliptical Gaussian model before beam deconvolution.degphys.angSize.sminAxisfloatnullablepa_rawPosition angle of the elliptical Gaussian model for the source before beam deconvolution, east of north.degpos.posAngfloatnullablefieldThe field name is the name of the coadded image containing the source. Note that the field name encodes the center of the field; field hhmmm+ddmmm is centered at RA = hh mm.m, Dec = +dd mm.m. The letter appended to the field name indicates the last catalog release in which the image was modified.meta.id;obs.fieldcharnullablen_sdssNumber of matching SDSS DR6 objects within 8 arcsec.meta.numberintd_sdssSeparation of the closest match in SDSS DR6.degpos.angDistancefloatnullableimagSDSS i-band magnitude of the closest match in SDSS DR6.magphot.mag;em.opt.Ifloatindexednullablec_sdssSDSS morphological class of the closest match in SDSS DR6; s = stellar, g = nonstellar/galaxy.src.morph.typecharnullablectRow count; this is not part of the original table but was added to satisfy SCS requirements.meta.id;meta.mainint
wdsdss10New white dwarf stars in the SDSS-DR10 The catalogue WDSLOAN10 has been constructed by spectroscopically +selecting white dwarfs and subdwarfs in the Sloan Digital Sky Survey +Data Release 10. It offers Teff, log(g) and mass for hydrogen +atmosphere white dwarf stars (DAs) and helium atmosphere white dwarf +stars (DBs), and estimatives of calcium/helium abundances for the +white dwarf stars with metallic lines (DZs) and carbon/helium for +carbon dominated spectra DQs.wdsdss10.main The catalogue WDSLOAN10 has been constructed by spectroscopically +selecting white dwarfs and subdwarfs in the Sloan Digital Sky Survey +Data Release 10. It offers Teff, log(g) and mass for hydrogen +atmosphere white dwarf stars (DAs) and helium atmosphere white dwarf +stars (DBs), and estimatives of calcium/helium abundances for the +white dwarf stars with metallic lines (DZs) and carbon/helium for +carbon dominated spectra DQs.9114raj2000Right ascensiondegpos.eq.ra;meta.maindoubleindexeddecj2000Declinationdegpos.eq.dec;meta.maindoubleindexedsnrg-band signal-to-noise ratiostat.snr;phot.flux;em.opt.BintuSDSS u band PSF magnitudemagphot.mag;em.opt.Ufloatu_errSDSS u band uncertaintymagstat.error;phot.mag;em.opt.UfloatgSDSS g band PSF magnitudemagphot.mag;em.opt.Bfloatg_errSDSS g band uncertaintymagstat.error;phot.mag;em.opt.BfloatrSDSS r band PSF magnitudemagphot.mag;em.opt.Rfloatr_errSDSS r band uncertaintymagstat.error;phot.mag;em.opt.RfloatiSDSS i band PSF magnitudemagphot.mag;em.opt.Ifloati_errSDSS i band uncertaintymagstat.error;phot.mag;em.opt.IfloatzSDSS z band PSF magnitudemagphot.mag;em.opt.Ifloatz_errSDSS z band uncertaintymagstat.error;phot.mag;em.opt.IfloatpmSDSS proper motionmas/yrpos.pmfloatt_effEffective TemperatureKphys.temperature.effective;meta.mainintt_errError effective temperatureKstat.error;phys.temperature.effective;meta.mainintlog_gSurface gravitylog(cm/s**2)phys.gravity;meta.mainfloatlog_gerrSurface gravity errorlog(cm/s**2)stat.error;phys.gravity;meta.mainfloathumanidHuman clssificationmeta.code.classchart_eff_3dTemperature (convective model) for pure DAs and DBsKphys.temperature;meta.modelledintnullablet_err_3dError temperature (convective model)Kstat.error;phys.temperature;meta.modelledintnullablelog_g_3dphys.gravity;meta.modelledfloatnullablelog_gerr_3dstat.error;phys.gravity;meta.modelledfloatnullablemassCalculated masssolMassphys.massfloatnullablemass_errMass uncertaintysolMassstat.error;phys.massfloatnullablelog_caCalcium/Helium emission lines ratiophys.abund;arith.ratiofloatnullablelog_ca_errCalcium/Helium emission lines ratio errorstat.error;phys.abund;arith.ratiofloatnullablelog_cCarbon/Helium emission lines ratiophys.abund;arith.ratiofloatnullablelog_c_errCarbon/Helium emission lines ratio errorstat.error;phys.abund;arith.ratiofloatnullablepdfSDSS object/observation identifiermeta.id;meta.maincharindexedprimary
wfpdbWide-Field Plate Database WFPDB +The Wide-Field Plate Database (WFPDB_) contains the descriptive information +for the astronomical wide-field (>1°) photographic observations stored in +numerous archives all over the world. The total number of these +observations, obtained since the end of the 19th century with more +then 200 instruments (telescopes) is about 2 550 000 from 509 archives. + +The WFPDB is continually being updated, providing currently access to the +information for about 640 000 plates from 117 plate archives (30% of the +estimated total number of wide-field plates) + +.. _WFPDB: http://www.skyarchive.org/wfpdb.archivesWFPDB Archives Table A table of plate archives included in the WFPDB or scheduled for +inclusion, as well as the properties of the instruments used to take +the data.509instr_idWFPDB-internal instrument designationmeta.id;instrcharnullablearchive_idWFPDB-internal archive designation, consisting of the instrument id, the archive code, and the site code.meta.id;meta.maincharindexedprimarywfpdb_statusInclusion status of plates from this archive: * - at disposal in SSADC, not yet converted in computer-readable form, ** - in preparation in SSADC, converted in computer readable form, *** - included in the WFPDB and available on-line.meta.codecharnullableinstr_nameOriginal name of the instrument as used by the relevant observatorymeta.id;instrcharnullablearchive_locationLocation of the plate archivemeta.id;instr.obstycharnullablearch_partCode for a sub-archive when an instrument's archive is split across several sitesintinst_nameName of the hosting institutioncharnullablesite_codeCode for the instrument site when the instrument was operated from several locations.meta.idcharsite_nameObservatory sitemeta.id;instr.obstycharnullablecountryCountry the observatory is located in.meta.id;pos.earthcharnullablempc_numberMinor Planet Center observatory codemeta.id;instr.obstyintnullabletime_zoneTime difference to Greenwichhtime;arith.difffloatnullablelongGeographical longitude of the observatory.degpos.earth.lonfloatnullablelatGeographical latitude of the observatory.degpos.earth.latfloatnullablealtitudeAltitude of the observatory.mpos.earth.altitudefloatnullablen_tubesNumber of telescope tubes.meta.number;instr.telcharnullableapertureClear aperture of the telescope.mphys.size;instr.telfloatnullablediameterDiameter of the primary mirror or the objective lensmfloatnullablefocal_lengthFocal length of the telescopeminstr.tel.focalLengthfloatnullableplate_scalePlate scalearcsec/mmfloatnullableinst_typeInstrument type: Ast-astrograph, Cam-camera, FEC-fish eye camera, Men-meniscus, RCr-Ritchey-Chretien, Rfl-reflector, Rfr- refractor, Sch-Schmidtcharnullableang_sizeMaximum angular size of the field of view.degphys.angsize;instr.fovfloatnullableop_beginYear telescope operations started.yrtime.epochfloatnullableop_endYear telescope operations ended.yrtime.epochfloatnullabledet_typeDetector used: blank--plate, F--film, X--film and platemeta.code;instrcharnullablen_directNumber of direct plates in the archive.meta.number;obsintnullablen_prismNumber of prism plates in the archive.meta.number;obsintnullablecontactName of the contact person.charnullable
wfpdb.mainWFPDB TAP-queriable Table WFPDB's table of plates, including position observed and the epoch of +observation.609884instr_idWFPDB instrument identifier. TDB: Foreign keymeta.id;instrcharindexednullablewfpdbidWFPDB identifier of the plate, consisting of an observatory identifier, the instrument aperture, an instrument suffix, a plate number, and a suffix to it.meta.id;meta.maincharindexedprimaryraj2000Right ascension of the plate center (ICRS)degpos.eq.ra;meta.mainfloatindexednullabledej2000Declination of the plate center (ICRS)degpos.eq.dec;meta.mainfloatindexednullablecoord_problemQuality flag for the coordinates (empty means no known problems)meta.notecharnullableepochEpoch of observation start (UT)yrtime.epochdoubleindexednullabletime_problemQuality flag for the epoch (empty means no known problems)meta.notecharnullableobjectObject or field name as given by observermeta.id;srcunicodeCharindexednullableobject_typeType of the target objectsrc.classcharindexednullablemethodMethod of observationinstr.setupcharnullableexptimeExposure time (for multiple exposures, this is for the first exposure; for the others, see notes)stime.duration;obs.exposurefloatnullableemulsionEmulsion typeinstr.plate.emulsioncharnullablefilterFilter typemeta.id;instr.filtercharnullablewavebandSpectral Bandinstr.bandpasscharindexednullablexsizeWidth of the platecmphys.size;instr.detfloatnullableysizeHeight of the platecmphys.size;instr.detfloatnullableobserverName(s) of the persons having performed the observation.obs.observerunicodeCharnullablenotesVarious longer remarksmeta.noteunicodeCharnullablequalityQuality-related information in free text.meta.noteunicodeCharnullableavailabilityFree text on how to find the plate.meta.notecharnullabledigitizationInformation on possible ways to access plate scans in free text.meta.noteunicodeCharnullablewfpdb.archivesinstr_idinstr_id
wiseWISE All-Sky Release Catalog +The Wide-field Infrared Survey Explorer (WISE) is a space-based imaging +survey of the entire sky in the 3.4 (W1), 4.6 (W2), 12 (W3), and 22 (W4) μm +mid-infrared. This is the project's reliable Source Catalog containing +accurate photometry and astrometry for over 500 million objects. + +More details are available in the `Explanatory Supplement`_, which also +has a list of `Cautionary Notes`_. + +.. _Explanatory Supplement: http://wise2.ipac.caltech.edu/docs/release/allsky/expsup/sec1_1.html +.. _Cautionary Notes: http://wise2.ipac.caltech.edu/docs/release/allsky/expsup/sec1_4b.htmlwise.main This is the All-Sky source catalog, with several columns left out +since we considered them to be only relevant for re-reduction, too +arcane, or just because of a whim on our side. If you need them, let +us know. The columns left out include: elon, elat, source_id, w?nm +w?m, w?cov, w?cc_map_str, w?flux, w?sigflux, w?sky, w?sigsk, w?conf, +w?mag_?, w?sigm_?, w?flg_?, w?magp, w?sigp1, w?sigp2, rho??, r_2mass, +pa_2mass, n_2mass, [jhk]_m_2mass, [jhk]_msig_2mass, best_use_cntr, +ngrp, x, y, z, spt_ind570000000designationSexagesimal, equatorial position-based source name in the form: hhmmss.ss+ddmmss.s. The full naming convention for WISE All-Sky Release Catalog sources has the form 'WISE Jhhmmss.ss+ddmmss.s,', where WISE is not given in this column.meta.id;meta.maincharindexedprimaryraj2000J2000 right ascension with respect to the 2MASS PSC reference framedegpos.eq.ra;meta.maindoubleindexednullabledej2000J2000 declination with respect to the 2MASS PSC reference frame.degpos.eq.dec;meta.maindoubleindexednullablesigraOne-sigma uncertainty in right ascension coordinate.degstat.error;pos.eq.rafloatnullablesigdecOne-sigma uncertainty in declination coordinate.degstat.error;pos.eq.decfloatnullablesigradecThe co-sigma of the equatorial position uncertainties, sig_ra, sig_dec (σα, σδ).degstat.error;pos.eqfloatnullableglonGalactic longitude. CAUTION: This coordinate should not be used as an astrometric reference.degpos.galactic.londoublenullableglatGalactic latitude. CAUTION: This coordinate should not be used as an astrometric reference.degpos.galactic.latdoublenullablewxThe x-pixel coordinate of this source on the Atlas Image.pixpos.cartesian.x;instr.detfloatnullablewyThe y-pixel coordinate of this source on the Atlas Image.pixpos.cartesian.y;instr.detfloatnullablecntrUnique identification number for the Catalog source.meta.idlongcoadd_idAtlas Tile identifier from which source was extracted.meta.idcharnullablesrcSequential number of this source extraction in the Atlas Tile from which this source was extracted, in approximate descending order of W1 source brightness.meta.id;obsintw1mproMagnitude at 3.4µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 3.4µm flux measurement has SNR<2. This column is null if the source is nominally detected in 3.4µm, but no useful brightness estimate could be made.magphot.mag;em.IR.3-4umfloatindexednullablew1sigmrpo3.4µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 3.4µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1snr3.4µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w1flux) to flux uncertainty (w1sigflux)in the W1 profile-fit photometry measurement. This column is null if w1flux is negative, or if w1flux or w1sigflux are null.stat.snr;phot.mag;em.IR.3-4umfloatnullablew1rchi2Reduced χ² of the 3.4µm profile-fit photometry measurement. This column is null if the 3.4µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.3-4umfloatnullablew1satSaturated pixel fraction, 3.4µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [3.4µm]~8 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew1frtrFraction of pixels affected by transients. This column gives the fraction of all 3.4µm pixels in the stack of individual 3.4µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew1cc_mapContamination and confusion map for this source in 3.4µmmeta.code.qualshortnullablew1mag3.4µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 3.4µmmcor.magphot.mag;em.IR.3-4umfloatnullablew1sigmUncertainty in the 3.4µm "standard" aperture magnitude. This column is null if the 3.4µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1flg3.4µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.3-4umshortnullablew1mcor3.4µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew1dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 3.4µm. Single-exposure measurements with w1rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.3-4um;arith.difffloatnullablew1ndfNumber of degrees of freedom in the flux variability chi-square, 3.4µm.stat.fit.dof;phot.mag;em.IR.3-4umshortnullablew1mlqProbability measure that the source is variable in 3.4µm flux.stat.fit.goodness;src.varshortnullablew1mjdminThe earliest modified Julian Date (mJD) of the 3.4µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew1mjdmaxThe latest modified Julian Date (mJD) of the 3.4µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew1mjdmeanThe average modified Julian Date (mJD) of the 3.4µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew1rsemiSemi-major axis of the elliptical aperture used to measure source in 3.4µmdegphys.angSize.smajAxisfloatnullablew1baAxis ratio (b/a) of the elliptical aperture used to measure source in 3.4µmphys.angSize;arith.ratiofloatnullablew1paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 3.4µmdegpos.posAngfloatnullablew1gmag3.4µm magnitude of source measured in the elliptical aperture described by w1rsemi, w1w1ba, and w1w1pa.magphot.mag;em.IR.3-4umfloatnullablew1gerrUncertainty in the 3.4µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.3-4umshortnullablew2mproMagnitude at 4.6µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 4.6µm flux measurement has SNR<2. This column is null if the source is nominally detected in 4.6µm, but no useful brightness estimate could be made.magphot.mag;em.IR.4-8umfloatindexednullablew2sigmrpo4.6µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 4.6µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2snr4.6µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w2flux) to flux uncertainty (w2sigflux)in the W1 profile-fit photometry measurement. This column is null if w2flux is negative, or if w2flux or w2sigflux are null.stat.snr;phot.mag;em.IR.4-8umfloatnullablew2rchi2Reduced χ² of the 4.6µm profile-fit photometry measurement. This column is null if the 4.6µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.4-8umfloatnullablew2satSaturated pixel fraction, 4.6µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [4.6µm]~7 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew2frtrFraction of pixels affected by transients. This column gives the fraction of all 4.6µm pixels in the stack of individual 4.6µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew2cc_mapContamination and confusion map for this source in 4.6µmmeta.code.qualshortnullablew2mag4.6µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 4.6µmmcor.magphot.mag;em.IR.4-8umfloatnullablew2sigmUncertainty in the 4.6µm "standard" aperture magnitude. This column is null if the 4.6µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2flg4.6µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.4-8umshortnullablew2mcor4.6µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew2dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 4.6µm. Single-exposure measurements with w2rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.4-8um;arith.difffloatnullablew2ndfNumber of degrees of freedom in the flux variability chi-square, 4.6µm.stat.fit.dof;phot.mag;em.IR.4-8umshortnullablew2mlqProbability measure that the source is variable in 4.6µm flux.stat.fit.goodness;src.varshortnullablew2mjdminThe earliest modified Julian Date (mJD) of the 4.6µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew2mjdmaxThe latest modified Julian Date (mJD) of the 4.6µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew2mjdmeanThe average modified Julian Date (mJD) of the 4.6µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew2rsemiSemi-major axis of the elliptical aperture used to measure source in 4.6µmdegphys.angSize.smajAxisfloatnullablew2baAxis ratio (b/a) of the elliptical aperture used to measure source in 4.6µmphys.angSize;arith.ratiofloatnullablew2paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 4.6µmdegpos.posAngfloatnullablew2gmag4.6µm magnitude of source measured in the elliptical aperture described by w2rsemi, w2w1ba, and w2w1pa.magphot.mag;em.IR.4-8umfloatnullablew2gerrUncertainty in the 4.6µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.4-8umshortnullablew3mproMagnitude at 12µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 12µm flux measurement has SNR<2. This column is null if the source is nominally detected in 12µm, but no useful brightness estimate could be made.magphot.mag;em.IR.8-15umfloatindexednullablew3sigmrpo12µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 12µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.8-15umfloatnullablew3snr12µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w3flux) to flux uncertainty (w3sigflux)in the W1 profile-fit photometry measurement. This column is null if w3flux is negative, or if w3flux or w3sigflux are null.stat.snr;phot.mag;em.IR.8-15umfloatnullablew3rchi2Reduced χ² of the 12µm profile-fit photometry measurement. This column is null if the 12µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.8-15umfloatnullablew3satSaturated pixel fraction, 12µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [12µm]~4 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew3frtrFraction of pixels affected by transients. This column gives the fraction of all 12µm pixels in the stack of individual 12µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew3cc_mapContamination and confusion map for this source in 12µmmeta.code.qualshortnullablew3mag12µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 12µmmcor.magphot.mag;em.IR.8-15umfloatnullablew3sigmUncertainty in the 12µm "standard" aperture magnitude. This column is null if the 12µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.8-15umfloatnullablew3flg12µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.8-15umshortnullablew3mcor12µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew3dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 12µm. Single-exposure measurements with w3rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.8-15um;arith.difffloatnullablew3ndfNumber of degrees of freedom in the flux variability chi-square, 12µm.stat.fit.dof;phot.mag;em.IR.8-15umshortnullablew3mlqProbability measure that the source is variable in 12µm flux.stat.fit.goodness;src.varshortnullablew3mjdminThe earliest modified Julian Date (mJD) of the 12µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew3mjdmaxThe latest modified Julian Date (mJD) of the 12µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew3mjdmeanThe average modified Julian Date (mJD) of the 12µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew3rsemiSemi-major axis of the elliptical aperture used to measure source in 12µmdegphys.angSize.smajAxisfloatnullablew3baAxis ratio (b/a) of the elliptical aperture used to measure source in 12µmphys.angSize;arith.ratiofloatnullablew3paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 12µmdegpos.posAngfloatnullablew3gmag12µm magnitude of source measured in the elliptical aperture described by w3rsemi, w3w1ba, and w3w1pa.magphot.mag;em.IR.8-15umfloatnullablew3gerrUncertainty in the 12µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.8-15umfloatnullablew3gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.8-15umshortnullablew4mproMagnitude at 22µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 22µm flux measurement has SNR<2. This column is null if the source is nominally detected in 22µm, but no useful brightness estimate could be made.magphot.mag;em.IR.15-30umfloatindexednullablew4sigmrpo22µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 22µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.15-30umfloatnullablew4snr22µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w4flux) to flux uncertainty (w4sigflux)in the W1 profile-fit photometry measurement. This column is null if w4flux is negative, or if w4flux or w4sigflux are null.stat.snr;phot.mag;em.IR.15-30umfloatnullablew4rchi2Reduced χ² of the 22µm profile-fit photometry measurement. This column is null if the 22µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.15-30umfloatnullablew4satSaturated pixel fraction, 22µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [22µm]~0 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew4frtrFraction of pixels affected by transients. This column gives the fraction of all 22µm pixels in the stack of individual 22µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew4cc_mapContamination and confusion map for this source in 22µmmeta.code.qualshortnullablew4mag22µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 22µmmcor.magphot.mag;em.IR.15-30umfloatnullablew4sigmUncertainty in the 22µm "standard" aperture magnitude. This column is null if the 22µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.15-30umfloatnullablew4flg22µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.15-30umshortnullablew4mcor22µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew4dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 22µm. Single-exposure measurements with w4rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.15-30um;arith.difffloatnullablew4ndfNumber of degrees of freedom in the flux variability chi-square, 22µm.stat.fit.dof;phot.mag;em.IR.15-30umshortnullablew4mlqProbability measure that the source is variable in 22µm flux.stat.fit.goodness;src.varshortnullablew4mjdminThe earliest modified Julian Date (mJD) of the 22µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew4mjdmaxThe latest modified Julian Date (mJD) of the 22µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew4mjdmeanThe average modified Julian Date (mJD) of the 22µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew4rsemiSemi-major axis of the elliptical aperture used to measure source in 22µmdegphys.angSize.smajAxisfloatnullablew4baAxis ratio (b/a) of the elliptical aperture used to measure source in 22µmphys.angSize;arith.ratiofloatnullablew4paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 22µmdegpos.posAngfloatnullablew4gmag22µm magnitude of source measured in the elliptical aperture described by w4rsemi, w4w1ba, and w4w1pa.magphot.mag;em.IR.15-30umfloatnullablew4gerrUncertainty in the 22µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.15-30umfloatnullablew4gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.15-30umshortnullablerchi2Combined reduced χ² of the profile-fit photometry measurement in all bands.stat.fit.chi2;phot.magfloatnullablenbNumber of PSF components used simultaneously in the profile-fitting for this source. This is greater than "1" when the source is fit concurrently with other nearby detections (passive deblending), or when a single source is split into two components during the fitting process (active deblending).meta.number;stat.fitshortnullablenaActive deblending flag. Indicates if a single detection was split into multiple sources in the process of profile-fitting.meta.code.qualshortnullablesatnumMinimum sample at which saturation occurs in each band. Four character string, one character per band, that indicates the minimum SUTR sample in which any pixel in the profile-fitting area in all of the single-exposure images used to characterize this source was flagged as having reached the saturation level in the on-board WISE payload processing. If no pixels in a given band are flagged as saturated, the value for that band is '0'.meta.code.qualcharnullablecc_flagsContamination and confusion flag.meta.code.qualcharnullableext_flgExtended source flag.meta.code;src.classshortnullablevar_flgVariability flag.meta.code;src.varcharnullableph_qualPhotometric quality flag.meta.code.qual;phot.magcharnullabledet_bitBit-encoded integer indicating bands in which a source has a w?snr>2 detection. For example, a source detected in W1 only has det_bit=1 (binary 0001). A source detected in W4 only has det_bit=8 (binary 1000). A source detected in all four bands has det_bit=15 (binary 1111).meta.code.qualshortq12Correlation significance between 3.4µm and 4.6µm.stat.fit.goodnessshortnullableq23Correlation significance between 4.6µm and 12µm.stat.fit.goodnessshortnullableq34Correlation significance between 12µm and 22µm.stat.fit.goodnessshortnullablexscprox2MASS Extended Source Catalog (XSC) proximity. This column gives the distance between the WISE source position and the position of a nearby 2MASS XSC source, if the separation is less than 1.1 times the Ks isophotal radius size of the XSC source. This identifies WISE sources that are identically the 2MASS XSC source as well as WISE sources that are fragments of large galaxies.degfloatnullabletmass_key2MASS PSC association. Unique identifier of the closest source in the 2MASS Point Source Catalog (PSC) that falls within 3" of the position of this WISE source. You can use this join to towmass.data, the pts_key column there.meta.id.crosslongnullable
xpparamsParameters of 220 million stars from Gaia BP/RP (XP) spectra We present astrophysical parameters of 220 million stars, based on +Gaia XP spectra and near-infrared photometry from 2MASS and WISE. +Instead of using ab initio stellar models, we develop a data-driven +model of Gaia XP spectra as a function of the stellar parameters, with +a few straightforward built-in physical assumptions. This resource is +a VO re-publication of the resulting catalog of stellar parameters. +For bulk downloads, the covariances, the trained model, and more, see +https://zenodo.org/record/7811871.xpparams.main We present astrophysical parameters of 220 million stars, based on +Gaia XP spectra and near-infrared photometry from 2MASS and WISE. +Instead of using ab initio stellar models, we develop a data-driven +model of Gaia XP spectra as a function of the stellar parameters, with +a few straightforward built-in physical assumptions. This resource is +a VO re-publication of the resulting catalog of stellar parameters. +For bulk downloads, the covariances, the trained model, and more, see +https://zenodo.org/record/7811871.220000000source_idGaia DR3 unique source identifier. You can match this against gaia.dr3lite on this TAP service.meta.id;meta.mainlongindexedprimaryraGaia ICRS right ascension for this object.degpos.eq.ra;meta.maindoubleindexednullabledecGaia ICRS declination for this object.degpos.eq.dec;meta.maindoubleindexednullableteffEstimated effective Temperature. Note that the raw HDF5 files released by Zhang et al. (2023) give Teff in a different unit (Kilokelvin).Kphys.temperature.effectivefloatindexednullablefe_hLog of Fe/H in solar unitsphys.abund.FefloatindexednullableloggLog of surface gravity in solar unitsphys.gravityfloatindexednullableextEstimated extinction parameter. To convert to the extension at a particular wavelength, multiply this by that wavelength's value in the extinction curve, available at https://zenodo.org/record/7811871/files/extinction_curve.txt?download=1 and in the footnote.magphys.absorptionfloatnullablemod_parallaxParallax estimated from the model.maspos.parallaxfloatnullableerr_teffError in estimated effective temperature. Note that the raw HDF5 files released by Zhang et al. (2023) give the error in Teff in a different unit (Kilokelvin).Kstat.error;phys.temperature.effectivefloatnullableerr_fe_hError in fe_hstat.error;phys.abund.Fefloatnullableerr_loggError in log_gstat.error;phys.gravityfloatnullableerr_extError in extmagstat.error;phys.absorptionfloatnullableerr_mod_parallaxError in the parallax estimated from the model.masstat.error;pos.parallaxfloatnullablechi2_optχ² of the best-fit solution. Divide by 61 to obtain χ² per degree of freedom.stat.fit.chi2floatnullableln_priorNatural log of the GMM prior on stellar type, at the location of the optimal solution.stat.fit.goodnessfloatnullableteff_confidenceA neural-network-based estimate of the confidence in the effective temperature estimate, on a scale of 0 (no confidence) to 1 (high confidence).stat.fit.goodnessfloatnullablefeh_confidenceA neural-network-based estimate of the confidence in the [Fe/H] estimate, on a scale of 0 (no confidence) to 1 (high confidence).stat.fit.goodnessfloatnullablelogg_confidenceA neural-network-based estimate of the confidence in the log(g) estimate, on a scale of 0 (no confidence) to 1 (high confidence).stat.fit.goodnessfloatnullablequality_flagsThe three least significant bits represent whether the confidence in effective temperature, [Fe/H] and log(g) is less than 0.5, respectively. The 4th bit is set if chi2_opt/61 > 2. The 5th bit is set if ln_prior < -7.43. The 6th bit is set if our parallax estimate is more than 10 sigma from the GDR3 measurement (using reported parallax uncertainties from GDR3). The two most significant bits are always unset. We recommend a cut of quality_flags < 8 (the "basic reliability cut"), although a stricter cut of quality_flags == 0 ensures higher reliability at the cost of lower completeness.meta.code.qualshort
zcosmoszCOSMOS Bright Spectroscopic Observations DR2 +The zCOSMOS redshift survey used 600h on the VIMOS spectrograph spread over +five observing seasons (2005-2009) to obtain spectra of about 20,000 galaxies +selected to have Iab < 22.5 across the full 1.7 deg2 of the COSMOS field. +This part, "zCOSMOS-bright", was designed to yield a high and fairly uniform +sampling rate (about 70%), with a high success rate in measuring redshifts +(approaching 100% at 0.5 < z < 0.8), and with sufficient +velocity accuracy +(about 100 km/s) to efficiently map the environments of galaxies down to the +scale of galaxy groups out to redshifts z ~ 1.zcosmos.data +The zCOSMOS redshift survey used 600h on the VIMOS spectrograph spread over +five observing seasons (2005-2009) to obtain spectra of about 20,000 galaxies +selected to have Iab < 22.5 across the full 1.7 deg2 of the COSMOS field. +This part, "zCOSMOS-bright", was designed to yield a high and fairly uniform +sampling rate (about 70%), with a high success rate in measuring redshifts +(approaching 100% at 0.5 < z < 0.8), and with sufficient +velocity accuracy +(about 100 km/s) to efficiently map the environments of galaxies down to the +scale of galaxy groups out to redshifts z ~ 1.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullabledatalinkA link to a datalink document for this spectrum.meta.ref.urlcharnullable
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta new file mode 100644 index 0000000000000000000000000000000000000000..23527e558af9fd80b68cb531f7c154bb07de5675 GIT binary patch literal 1431 zcmY*ZU2hvj6pg48TXCopB6xu!KPDw!f2QC(Q6;6&QpZXIJOCQa?p}MhS?_FTW)mAJ z5`95Lnm303!y~_h-@zGsZKsi(oqOlrJ2U6pbAK=WZ8kUNf4BC)RF&pBS1b@A*_Z#C zazs2NsjS(T^fo7@m8Z1K1D#89-czpVyHruCVjW-8SsZBlmpy!EZ>`y4N()KWR0EMD z6zEu_$f=%7l%#MOdx3NJwB)H8k!(=+@j5USwhF8*3wRSykpQ;ZP*TQ$TTx-1wlyIgiO`w{&!1i5 ze=ZYiK997{PMS?gV{hEJ7M_sfrsf%begf*E52DREO;IJP9y$)Ta{$`lV?5WI?H`=+ zbYXm%&3-&@w!J4_NY~x&7vp}<|Efn_FLa=_IzVtZ!xhqI*K46J)}_rUXJR%beUU=Oe_`&c-iCTW4E&nR?uf*>+TBEm20m6Q=QI(UU0dFwahY+#KFv(hYm|`k@N;3X8(*vJWuo@ zYq$t2+8#8fq*cJtFn^*YMnR|lp)aV2g<`_v z6pl{|M^TC8DY`x$#g0du@JX?qs`q#9%%t!C< zXIw|{?kWnPc$P__1=I{QHytSWKDbfJk+RGD1iemSadTx4;p0gnZtnR8ro>WlV_*FI z-#?W5(bu;&`lT>T$rs_w4p16wC^teXm@*lr2H9V&G7p&x04;9Vh|~^pADWqP9YmM| z15;&aeFl+e#UNG~N$h*Dk#DL)_q`wm-azt!DY*wA?7l(}c3&iB!$wJj_;+|Gd%L(2 z)A58vu5n=TKFBtVB^pw}S7vj1W{!LeKuLUpc&w2?5w literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD new file mode 100644 index 00000000..0d072011 --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD @@ -0,0 +1,27 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAEzIwMTUtMDctMDlUMDg6MDA6MDAAAAATMjAyMy0wNC0yMFQxMjowNjo0NQAAAAAAAAAHY2F0YWxvZwAAAAdiaWJjb2RlAAAAEwAyADAAMAAwAEkAQQBVAEMALgA3ADQAMwAyAFIALgAuAC4AMQBWf8AAAAAAAAV4LXJheQAAADRodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3Jvc2F0L3EvaW0vc2lhcC54bWw/AAAAFml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta new file mode 100644 index 0000000000000000000000000000000000000000..77d9e295cc24d0ce6cedad9d4af86b369b3c13a3 GIT binary patch literal 3153 zcmd^BU2oG?7_LTXJK9k?v`N!I$}WmpOq{Q_G)P>8G=)N%lq7|5u^pY*C$Xtxn{$qn zW)jl4nO4bn^Zw5+_e=IW_8i+uS|)X@w~MU!yszJ{^M3z4|NH*RT>N_^#N71hso-3IvvvTZ%Z>5@oof!Ov`o3cuR9!50njLzQ zb{(dj4jk|Xq8l!zPK&~?Chj8x&p6Si_}iqF__f)63lAM}?{qwI;6}Jari7~#0r~*3 zap1?*BhGvZN2U^HYzqS>EziU~kDBdH6kZFs6NPsyDg8&e9A|yK4`X$Y_j8i^IWcyP z$okB>9*50ZvX(bhOl|~laF+IQ{V2R~tbj@aJoLw}nz@3$qnm74Drx=lR(E%cm2^`% zF<*p7kH)aT&6V^*0kPPq+iq~WsXV$$4TJgeT%1=c31$}Mwf;}G{~%+so`X0&$aJ~l zTu3-^NEmRh`?>q-%MC=yP4Wu>Vl)Fz81u8#L24?(o0D)l%YF58ah#piJntF3*sX2JtWr{ zMykN+3DaAUgtzxtj|PrRxQ-ICwCa#FE|bEb$k$(yfIXvF-r0`MP{24A@?}B=nNl>u z70WhRYGe^)U!c5E#KiOl)OLaRHbtb8NZ_LA?4GSs9U8t)KfB`Mm$UHJ>`N-_#awu2 zh7?Q^+eO=;4zxKAZgv)adGWhX5hW#x8E81f=brS?OyJGy$|-nX8wsJ}b>zR2DN+ z%SE&a9CaLTbPm@D=ZWi$qUS&U^#=>O*0cAKWu`zl-}TIK^!@I_++3^n^0?OSJT|?T z0psI)^-AOEB{Kb|| z45SH295!UmgwJHc;I^;YNPe)IbW#X|Gm1`11ba6HS*$hiRYOY*u=|!2@%N-j z&CKxv4q+-msZ<0aK@6!Aq!#v}ns`05n?B{SxDg$)E_LHG?x|_GDf&4_YbLbcUoY-f zo0WR4U9I7$DpMc<5_8v!596n-bg5IRl05!cd)3qg^QV}EPOG%FnTYrf|Edy$$~9pt zN!))Wo#$kHno`@9y{TKTq;e|ZKPcp0k~>#ds3d%vLi7#tQ952p?MHHA<p07UYuhdCOHYHQRy7FDs`=1+wW-2<4&!mJ#QW~G*Ce(?b?nl$CuN=$&B}? z!7eBJhdr057SbRB-3ZO#8OTr7Z;) z3hFUxFv^8mf0vNdJ~mz!{Sb-pCQ;J`GhHppo*Oj+ zwH%-!8y0rhM!2lHC&4}^1;O?Kz_GhJVDN{_N9x^T0z)4g!bUi+rXR@8?{ZQ2`D~pF z=OQbx0vUb4h$Qb4gNU>T%mcD98I5T8rp*yn0o)>qC;M3K4XV{MI>7NdF&I}YOKSX{ Ys#PXl5W`hsVEM;TN_YS0Ea(RM-|h-b#Q*>R literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y new file mode 100644 index 00000000..1285563b --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y @@ -0,0 +1,7 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta new file mode 100644 index 0000000000000000000000000000000000000000..49a3bb6cdfcf3bf8ac2c026518859e3daba5f95a GIT binary patch literal 3168 zcmb^!OLNmkI8#EBI)p%(cBWI9+4@2Pk>ppN*kO!qAYklZJJ23Fnw7M+mdKLWUBxjo z%#=%~nbEE4|LL*6q`#xzO0u0$+Vp@A_U^ae`|Y3Se?Pi57k}PIYvD2%SOi=*J&Q!o z{|pyxf-S;$6y9RwZ9ur-Di4W_qq5u296-2fAyu^xBKB-(uf)sEMUv+NpBl32Zpz{^`&G z+JGD3V(PRg{CeU(edw9T>J)xU?<9V08*jivhs--2PaL=wF6mRm)d>T22(fX%kE@4_ z_!u0Sa+r}V42iHk3+y~>cY9HIC16ez-nNDC_cV=>fjR(XRgVocfqjjST{E)3u&>5p zvzP4Ubs3XP01j600L+iV%#plQlgqY0e%03U>XvGelVb7yV7FxKlt@vvq!V)m@ZaGW zG;p<|n$JTl)|%7}PS>SJSFvdlU!05cYBhn(qI`4kj`|zOB7Fzqw1EsJDHjq-I3xsM z*FEi?e91tR+$6u?0x_ChjtTJ<>_BQt#OsrAI>a3a8vv7lHdDZSesgx?-X=1jVrIkNY5~vMR-y7J;=N2GtG6d~R3AT%TgJ!fQ6QNUCH3&{m-Kp~7{`8)E7L;JXx% za?%4ADw6i8tOJnnP5SKei!W#4joC}e?D<@Hdj{l0=+uRtf*p|NIAGaX_|?UCA43Qw zD`G-7(tYL$4>}Ea^Qv?T{9YMxE`xbPHykKCVx^k%XdPhKalFwvSSy^@U2haU!+-rj z0>gg#KC-R!63!c*HI5$LTbP?ul*{6~B9k!g8+FQkPxeO7-9zV6#l=HX$#xnqj~d-x zb|tftvAmZ7VdIs|=VRZjww}bitM!-7&&e3H?)(^Y?lzi@S`X0^k6Igu5m~U7POS|3 z=<~SKet{T+&Ic%R5ZKiJ2NFWh+6OHJO-T=Y$HSINEsm;P|*~$d|Np7#7Had;Ov{Y|hPJ_x_%Hs)S8RNSbRQQ~pK00i+tM%B`VE+bm z96a2E)8~`{?6MC~pF&fNvr^t=MwTDKBtuZp9PF-S^J*@OCgZu14Mbnr$v)iAl)qOL z1cS>8Ok$xC6*j_9sGdJosi&qxal!^|ss%NlxGSAUqtQs65Xg~)6a|>RYWJ#-nvDsa z6kp0BP{`$#>^Vxv2CPEM(%?x0BH4Mgle}6?k@rqHy+AN3#)Ger%jLBnUNpO=O@>&Z zE^I!oNq~yeJsty_UNYJ*kpHVZbeU4Aatauto^mU@pF!nLquV~})EX$xs4VPM(7CyM zLgmpXYGn~-439Z|2MweIX3E)3jmsyN0F3L6Zmn~0*gI&qVo4~eWRAQ(GO=q>C}$+IoSKBkQ7da7)0DMXy+qS` zwO36zCHl|qU{EKO0mu42=mE@ROW@ zYF5G+fTPhUV}S(`)%Qc|Xuq}YerxV%X#%1TB~A{gFW zZo^9uTp#)#iGGTBcwLwC1g3a08=_Vq*MT7xka;X>h08kZY`R=9xDLw*TpVhsa0mKu z`B46L;$(rHU@e@Nxd&+HSGy?ua<<)tbCDg`frvi9P}JWh3h9Cli3h;eWEjG_X;B87 y6bIO%9?$Zz+!SDwX9N%7cvUwElO#)W;GW9mCEgdqRo#UD0{Zl?Ky(%uf%-Q_!#bG& literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ new file mode 100644 index 00000000..3a5f30c1 --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ @@ -0,0 +1,27 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjMtMTAtMTdUMTI6NDI6NTQAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAABEaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAAgaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta new file mode 100644 index 0000000000000000000000000000000000000000..adcdbedde14fe959e9790a9451a364d568dc5b3e GIT binary patch literal 3163 zcmd^CU2oG?7_LTXJK9k?v`N!I>Mn{}Oq{Q_G)P>8G=)N%gd~M=F`b>*C$Xtxn{$qn zW)jl4nO4bn^Zw5+_e=IW_8i+uS|)X@w~M0qyszJ{^M2>&`QMu>bMfbWv>7f7No632 z;h8LY@n^VbF={d{qVP6n?*b;I(1qlIAp_17wn7CvbOm#TE$t!Ow+$Kn7Hxfq-bdjA z5z^x<3YQJfahM@(&jrtNgF_@UC$uf-U6Y);qQ`iKxzKI9{U}`POmNjHZqcv;_k@|z zFAy&nA2N^Zyg=FSy*3A}jdQs0Qo_Ui>7&N~hKkgoR?t}H* z&iVoCt`~BJ?e%=|(e}=x-1hp@qmH6qF+5i?S7zkc2j5C11v@eL4fTD;HmJH-_B1o} zB<(s(I~_RS4MaCwOq~{mUrpRc2A*-EPw}@&EAeZi`xYK*a_@9Jao}dSM5ctR69M`F zv2ozX)h1^?g(Fi5Gq!~Rla^=Vp3O$P6NT3T?nL1oOG^JyHp^LG@55N#WHwB6m?W<}jp zPRteH(dHNyxY?qf&m$I_HQNnNx0FX$sbMf*o{RHpIl;`Lyw?B8_8+X9tmhz357xU} zaV{jBI3x_X*Zu5$_2vemL4{0;mt`n9p?6>1;iwvwG=U*-^~>i z>E)6C?qcLeqfw^k@j(WTjuSY}P?Z5oC?)U2R<&|#8o?=QEe)Nh#6-_2p9OJ|_#TpL z3?o(G^n~dxNW$CutVaV!CS1*gEUh{ujmxAkDDw4JBw)`dly-NbGZZk6`CN%mL8cV- zaK*AsmKs?A*%v5p6frTq0kvHqzD*ISBoeqNI=g49RELJI)7P%J_~tCUHG7i^dodT@ znIQ#}#CFj(r~_?|gPWa&UtWCgQ$$ILVg?!x@wq2GG!uC9x^fDh*G599c-iLPWiCj2I8nu!SAlB zyvkv#Qd8BLFK#P1pI5&*9S>AyT%3l7UXBT$V$KOJ>AU%2Zl|=DE0)w}k7e=?wI|ii z>uR;G2|u|Y8Up1qHfD-qs%I!8pSBvuP3_4W9RC+x@?tuv35B69)FQlu^!Bm)vgn6M zgg1$rGnnpbW%k^t9;h_|t=X`!&DO(Z)kg_7J1GeE5CD$d)d7P)TyCmoiwTT>>%?GOu`H=Ue5#h3cvTEniGjZX7*FZHfaomf2KwKjJy4$j literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr new file mode 100644 index 00000000..456f3d12 --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr @@ -0,0 +1,28 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta new file mode 100644 index 0000000000000000000000000000000000000000..f567e80c496cbf398adfb06244453c84cc1be4cf GIT binary patch literal 3287 zcmds4T~FIq7)C1vR#+*kHfdTbv5QntH%{X4l}f!xLuhG3LPKcRi|OpdK8al%+dbzP z$fQc^%`_z6&HFpkE_botvEQ-h*iHhS#5yh)Me%uGzhCG5&X3c-{<$!feBQ+?(Y%mU zhJu*B#p36GM6))d7ULq0ZgciFWI_sENFJIpS9qw+^+S7xAp;vTcS)MpTGV2xV7L1}^){BZ~+M*H$O>ZZUyL-O( zV7a)yyu-T7M$uSXE|njytv@WTEkD`oDEbA{_ayUVUJe8BEz~lwlYn2*AaEU%s*4p) z^T)oVU6*O60~frZ=ti@d)8gohk^9KNH;?o&{x)f+er7w5%likU=tssDo$JXp3^&qbUb zEO)u$oJl!xNEvXi`-S`J%?(7!OY;i=Vl)Ac7z^^$MQSR-o1<{L%2Ic%On5I#mJwWoaB2xALQZaB!QC*RT(gcQu2=+RV%l~5genIve1cILiCLCNf2jA z;3K()Fj56hPnq6;B)YxLdNg!p%C(=8WmSiy@t71QMZW%w1nikcWn(=)LjmJhDpm*; zWK7YF7Hr32nUMy_K0|q7J7sN(_gb%w|!kWzA>lPgx8W8blIMomLIB&tcMv#@Z6rmZ5h9HkK{_df$r(i_C4#*jgDlY+2CAW@1~`3N zisXITq$cM0A%`%Ppj0XXks^+%8)g>vp_=$Tw3|NViMSJb%(~P|&bX(h;il;49Ictq zem`ey)mqg?{h(IIQB|fu0;J~VjLqa*QM%NrTur~hPDlJv=zaJWO*EP_x=OY*!mvqrTJ8T8Eu_TYJ{pZEB!`P}+4|M-DHi zgOeHWQIlOx_78h5QLT#DVv;)Uu&-tA^hVRrR&q zcCDd0L#e!`;8IEb7Ii!lF#t>-a|GK(hB+s=qHmPS#r4Wov0PD~EtW5BYLDxkSM_>R z6G7@UG$YDoV$2xDRKHS2K54fO_qE5bam2O${~h{bDy!*;g+iz$d=8l#VDDz}cd>|W z5;fznS*Ug0_u^)#R+J<`ut_(gdDX)Swn`}ob|3(*)71fkKbqfH&o&cSJ+P;&MAK>p zgY5i98AqQ^mda=}n9AOo}&5~rl7^>|>4ID-X jI9?|v +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFw
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta new file mode 100644 index 0000000000000000000000000000000000000000..68d1f18e72a13f7c90582cd3cd96626687944a6f GIT binary patch literal 3161 zcmb^!OLNmkI8#EBItd|V+L=yaX6qhEAd>uu0||B*V;cxKwy_;(4;{@~ySA3dlF+W= zm>FiurBh~ftNMR>?5RJazoXwuvYk-c^bjBH-EY75+ds|!)>xT~KJUVfV3`Xne6AY~ zq2cpCf<=>JLOmV^H$3{rr(AHA3(q%%?@I`Q z9FK;<;)ZX4vT3lH18Pd$a&Ae-5PFj((SV6`c1(J+1cn3C{k zV9%*{LOnQilEbYkt~~8%IdxafAu(cHQ1XiQv|L8bs~Jf%Pp|-m=Bv@qtwYD&LYV@3 zOnWGo$!()-es6ncudt1t9CjuCis9IT+CmXy7wA?h$+a6@zs9a>F#}7(v{U885x8g3 zyQf17Xno!b789q1!Iu;F=|jgjR;TbAdOP-Ov-cW2)bgCu@x*}}!IC~jT$?aZhY%YJ z{J7TgsEfgo35OZk!jKBnAz){#+3AMC72mVM;HD{ryQgU$9jF6PR&~6ACa|mVv2BFr zXXe!?Z03@=yeVUn^1;Ch9)S5_kUEl=a(ubxj$bylth%ETdXmrI9qexR?r+n)N~9Ar zIq+y}3>w&4Ud?7978`YD`=^`IqifhOs4LFId955nW>H=ryk+hdBD8NooVHNUlavcF zB^+V`u&;Zf6$+ z$n;o(I&+ShETrqx@J>PNNnCj)LVAY1S%epL*MZC%g9S3GYE1MRP=Xs(+Q*<>Ox23f zl9GgsvZ>$(hGhN)va=6L?G(ZfP~C9MW_ESV^(jUpSTPx)iIO=$TZP((3fGA<#LNc3 zHwhr&r295hB?s|@JpwoaiuS%!D@0AhfGMLx(o&{w`NuoIqHvxt%%Nd=4HG+BFc1Gc| zKmYoj`aSdMyU--bC7ACyWE?*FZeeatQ7($_s!YPDZ&Vp~9oZWldk>vS6&nv}Dc!EU zII4BJ>DAO~ia0NP>Wx=Zm&d+dZaj&2m#Z)8m&q8kZvPN*?$qkFN*A#chmkGhQCYA= zXC#F_`aEto50U3V=K~Zu2u$Yw0|}vL&4UJlrlk9>)*nDh*0u^U_JOb98c(k7*|5thFBBc`L6fi_R!WdYADL6H0)H+ zxw(8o#mIhnLdC}iwR#mDR7+__(g=GV9&`2<8pt-7DQ8bi?%PZ*ZWR-IX*7vt8uNzHq>>EGwkNzThI|qprQu& zan8VT!sSAK&_+H<2|$@zQ`NwvMC;@QWEHhZXdoA5UP+35D2j`_v!bk~zVgV`Vg^gfYhhZ)op0Bme*a literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg new file mode 100644 index 00000000..9d3e1343 --- /dev/null +++ b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg @@ -0,0 +1,23 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjMtMTAtMTdUMTI6NDI6NTQAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD86OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vb2JzY29yZS9kbC9kbG1ldGE6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcDo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS90YWJsZU1ldGFkYXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9hdmFpbGFiaWxpdHkAAAEQaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3RhcCNhdXg6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSN0YWJsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNjYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNhdmFpbGFiaWxpdHkAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAAAAAAFWl2bzovL29yZy5nYXZvLmRjL3RhcAAAABF2czpjYXRhbG9nc2VydmljZQAAAAtHQVZPIERDIFRBUAAAABwARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAgAFQAQQBQACAAcwBlAHIAdgBpAGMAZQAAAAAAABQZAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABUAEEAUAAgAGUAbgBkACAAcABvAGkAbgB0AC4AIAAgAAoAVABoAGUAIABUAGEAYgBsAGUAIABBAGMAYwBlAHMAcwAgAFAAcgBvAHQAbwBjAG8AbAAgACgAVABBAFAAKQAgAGwAZQB0AHMAIAB5AG8AdQAgAGUAeABlAGMAdQB0AGUAIABxAHUAZQByAGkAZQBzACAAYQBnAGEAaQBuAHMAdAAgAG8AdQByAAoAZABhAHQAYQBiAGEAcwBlACAAdABhAGIAbABlAHMALAAgAGkAbgBzAHAAZQBjAHQAIAB2AGEAcgBpAG8AdQBzACAAbQBlAHQAYQBkAGEAdABhACwAIABhAG4AZAAgAHUAcABsAG8AYQBkACAAeQBvAHUAcgAgAG8AdwBuAAoAZABhAHQAYQAuACAAIAAKAAoASQBuACAARwBBAFYATwAnAHMAIABkAGEAdABhACAAYwBlAG4AdABlAHIALAAgAHcAZQAgAGkAbgAgAHAAYQByAHQAaQBjAHUAbABhAHIAIABoAG8AbABkACAAcwBlAHYAZQByAGEAbAAgAGwAYQByAGcAZQAKAGMAYQB0AGEAbABvAGcAcwAgAGwAaQBrAGUAIABQAFAATQBYAEwALAAgADIATQBBAFMAUwAgAFAAUwBDACwAIABVAFMATgBPAC0AQgAyACwAIABVAEMAQQBDADQALAAgAFcASQBTAEUALAAgAFMARABTAFMAIABEAFIAMQA2ACwACgBIAFMATwBZACwAIABhAG4AZAAgAHMAZQB2AGUAcgBhAGwAIABHAGEAaQBhACAAZABhAHQAYQAgAHIAZQBsAGUAYQBzAGUAcwAgAGEAbgBkACAAYQBuAGMAaQBsAGwAYQByAHkAIAByAGUAcwBvAHUAcgBjAGUAcwAgAGYAbwByAAoAeQBvAHUAIAB0AG8AIAB1AHMAZQAgAGkAbgAgAGMAcgBvAHMAcwBtAGEAdABjAGgAZQBzACwAIABwAG8AcwBzAGkAYgBsAHkAIAB3AGkAdABoACAAdQBwAGwAbwBhAGQAZQBkACAAdABhAGIAbABlAHMALgAKAAoAVABhAGIAbABlAHMAIABlAHgAcABvAHMAZQBkACAAdABoAHIAbwB1AGcAaAAgAHQAaABpAHMAIABlAG4AZABwAG8AaQBuAHQAIABpAG4AYwBsAHUAZABlADoAIABuAHUAYwBhAG4AZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbQBhAG4AZABhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAG4AbgBpAHMAcgBlAGQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAMQAwACAAcwBjAGgAZQBtAGEALAAgAGQAcgAxADAAIABmAHIAbwBtACAAdABoAGUAIABhAHAAYQBzAHMAIABzAGMAaABlAG0AYQAsACAAZgByAGEAbQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABhAHAAbwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQBwAHAAbABhAHUAcwBlACAAcwBjAGgAZQBtAGEALAAgAGcAZgBoACwAIABpAGQALAAgAGkAZABlAG4AdABpAGYAaQBlAGQALAAgAG0AYQBzAHQAZQByACwAIABuAGkAZAAsACAAdQBuAGkAZABlAG4AdABpAGYAaQBlAGQAIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBnAGYAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQByAGkAaABpAHAAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAdQBnAGUAcgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABwAGgAbwB0AF8AYQBsAGwALAAgAHMAcwBhAF8AdABpAG0AZQBfAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAYgBnAGQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYgBvAHkAZABlAG4AZABlACAAcwBjAGgAZQBtAGEALAAgAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYgByAG8AdwBuAGQAdwBhAHIAZgBzACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAZgBsAHUAeABwAG8AcwB2ADEAMgAwADAALAAgAGYAbAB1AHgAcABvAHMAdgA1ADAAMAAsACAAZgBsAHUAeAB2ADEAMgAwADAALAAgAGYAbAB1AHgAdgA1ADAAMAAsACAAbwBiAGoAZQBjAHQAcwAsACAAcwBwAGUAYwB0AHIAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBsAGkAZgBhAGQAcgAzACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABzAHIAYwBjAGEAdAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAIABzAGMAaABlAG0AYQAsACAAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAYQByAGMAcwAgAHMAYwBoAGUAbQBhACwAIABsAGkAbgBlAF8AdABhAHAAIABmAHIAbwBtACAAdABoAGUAIABjAGEAcwBhAF8AbABpAG4AZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1AHUAcABkAGEAdABlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAHMAOAAyAG0AbwByAHAAaABvAHoAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AIABmAHIAbwBtACAAdABoAGUAIABjAHMAdABsACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABkAGEAbgBpAHMAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBwAGwAYQB0AGUAcwAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBfAHMAcABlAGMAdAByAGEALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAG0AdQBiAGkAbgAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZQBtAGkAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABmAGsANgBqAG8AaQBuACwAIABwAGEAcgB0ADEALAAgAHAAYQByAHQAMwAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAawA2ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQByAGUAXwBzAHUAcgB2AGUAeQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABvAHIAZABlAHIAcwBtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBsAGEAcwBoAGgAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBvAHIAbgBhAHgAIABzAGMAaABlAG0AYQAsACAAZAByADIAXwB0AHMAXwBzAHMAYQAsACAAZAByADIAZQBwAG8AYwBoAGYAbAB1AHgALAAgAGQAcgAyAGwAaQBnAGgAdAAsACAAZAByADMAbABpAHQAZQAsACAAZQBkAHIAMwBsAGkAdABlACAAZgByAG8AbQAgAHQAaABlACAAZwBhAGkAYQAgAHMAYwBoAGUAbQBhACwAIABoAHkAYQBjAG8AYgAsACAAbQBhAGcAbABpAG0AcwA1ACwAIABtAGEAZwBsAGkAbQBzADYALAAgAG0AYQBnAGwAaQBtAHMANwAsACAAbQBhAGkAbgAsACAAbQBpAHMAcwBpAG4AZwBfADEAMABtAGEAcwAsACAAcgBlAGoAZQBjAHQAZQBkACwAIAByAGUAcwBvAGwAdgBlAGQAcwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBjAG4AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZwBjAHAAbQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGEAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMgBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHAAaABvAHQAbwBtAGUAdAByAHkAIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAsACAAdwBpAHQAaABwAG8AcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADMAcwBwAGUAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAGEAdQB0AG8AIABzAGMAaABlAG0AYQAsACAAbABpAHQAZQB3AGkAdABoAGQAaQBzAHQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAZABpAHMAdAAgAHMAYwBoAGUAbQBhACwAIABnAGUAbgBlAHIAYQB0AGUAZABfAGQAYQB0AGEALAAgAG0AYQBnAGwAaQBtAF8ANQAsACAAbQBhAGcAbABpAG0AXwA2ACwAIABtAGEAZwBsAGkAbQBfADcALAAgAG0AYQBpAG4ALAAgAHAAYQByAHMAZQBjAF8AcAByAG8AcABzACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBzAHAAdQByACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAHMAZQByAHYAaQBjAGUAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGwAbwB0AHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAcABzADEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAZABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABoAGkAaQBjAG8AdQBuAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAGkAcABwAGEAcgBjAG8AcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABwAHAAdQBuAGkAbwBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHMAbwB5ACAAcwBjAGgAZQBtAGEALAAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAaQBjAGUAYwB1AGIAZQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAaQBuAGYAbABpAGcAaAB0ACAAcwBjAGgAZQBtAGEALAAgAG8AYgBzAF8AcgBhAGQAaQBvACwAIABvAGIAcwBjAG8AcgBlACAAZgByAG8AbQAgAHQAaABlACAAaQB2AG8AYQAgAHMAYwBoAGUAbQBhACwAIABlAHYAZQBuAHQAcwAsACAAcABoAG8AdABwAG8AaQBuAHQAcwAsACAAdABpAG0AZQBzAGUAcgBpAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAMgBjADkAdgBzAHQAIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMAIABmAHIAbwBtACAAdABoAGUAIABrAGEAcAB0AGUAeQBuACAAcwBjAGgAZQBtAGEALAAgAGsAYQB0AGsAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAawBhAHQAawBhAHQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADUAIABzAGMAaABlAG0AYQAsACAAcwBzAGEAXwBsAHIAcwAsACAAcwBzAGEAXwBtAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADYAIABzAGMAaABlAG0AYQAsACAAZABpAHMAawBfAGIAYQBzAGkAYwAsACAAaABfAGwAaQBuAGsALAAgAGkAZABlAG4AdAAsACAAbQBlAHMAXwBiAGkAbgBhAHIAeQAsACAAbQBlAHMAXwBtAGEAcwBzAF8AcABsACwAIABtAGUAcwBfAG0AYQBzAHMAXwBzAHQALAAgAG0AZQBzAF8AcgBhAGQAaQB1AHMAXwBzAHQALAAgAG0AZQBzAF8AcwBlAHAAXwBhAG4AZwAsACAAbQBlAHMAXwB0AGUAZgBmAF8AcwB0ACwAIABvAGIAagBlAGMAdAAsACAAcABsAGEAbgBlAHQAXwBiAGEAcwBpAGMALAAgAHAAcgBvAHYAaQBkAGUAcgAsACAAcwBvAHUAcgBjAGUALAAgAHMAdABhAHIAXwBiAGEAcwBpAGMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZgBlAF8AdABkACAAcwBjAGgAZQBtAGEALAAgAGcAZQBvAGMAbwB1AG4AdABzACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwB0AGEAdABpAG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAGcAaAB0AG0AZQB0AGUAcgAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQB2AGUAcgBwAG8AbwBsACAAcwBjAGgAZQBtAGEALAAgAHIAbQB0AGEAYgBsAGUALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABsAG8AdABzAHMAcABvAGwAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwBwAG0AIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMALAAgAHcAbwBsAGYAcABhAGwAaQBzAGEAIABmAHIAbwBtACAAdABoAGUAIABsAHMAdwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbQBhAGcAaQBjACAAcwBjAGgAZQBtAGEALAAgAHIAZQBkAHUAYwBlAGQAIABmAHIAbwBtACAAdABoAGUAIABtAGEAaQBkAGEAbgBhAGsAIABzAGMAaABlAG0AYQAsACAAZQB4AHQAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYwBlAHgAdABpAG4AYwB0ACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAcwBsAGkAdABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAbQBsAHEAcwBvACAAcwBjAGgAZQBtAGEALAAgAGUAcABuAF8AYwBvAHIAZQAsACAAbQBwAGMAbwByAGIAIABmAHIAbwBtACAAdABoAGUAIABtAHAAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIABzAHQAYQByAHMAIABmAHIAbwBtACAAdABoAGUAIABtAHcAcwBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAZQAxADQAYQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbwBiAHMAYwBvAGQAZQAgAHMAYwBoAGUAbQBhACwAIABiAGkAYgByAGUAZgBzACwAIABtAGEAcABzACwAIABtAGEAcwBlAHIAcwAsACAAbQBvAG4AaQB0AG8AcgAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AaABtAGEAcwBlAHIAIABzAGMAaABlAG0AYQAsACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAbwBuAGUAYgBpAGcAYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABzAGgAYQBwAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AcABlAG4AbgBnAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAYwBjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAHQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABvAGwAYwBhAHQAcwBtAGMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABtAGEAcABzACAAZgByAG8AbQAgAHQAaABlACAAcABwAGEAawBtADMAMQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABwAG0AeAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIAB1AHMAbgBvAGMAbwByAHIAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4AGwAIABzAGMAaABlAG0AYQAsACAAbQBhAHAAMQAwACwAIABtAGEAcAA2ACwAIABtAGEAcAA3ACwAIABtAGEAcAA4ACwAIABtAGEAcAA5ACwAIABtAGEAcABfAHUAbgBpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcgBkAHUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGQAcgAyACwAIABkAHIAMwAsACAAZAByADQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAByAGEAdgBlACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABwAGgAbwB0AG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAcgBvAHMAYQB0ACAAcwBjAGgAZQBtAGEALAAgAGEAbAB0AF8AaQBkAGUAbgB0AGkAZgBpAGUAcgAsACAAYQB1AHQAaABvAHIAaQB0AGkAZQBzACwAIABjAGEAcABhAGIAaQBsAGkAdAB5ACwAIABnAF8AbgB1AG0AXwBzAHQAYQB0ACwAIABpAG4AdABlAHIAZgBhAGMAZQAsACAAaQBuAHQAZgBfAHAAYQByAGEAbQAsACAAcgBlAGcAaQBzAHQAcgBpAGUAcwAsACAAcgBlAGwAYQB0AGkAbwBuAHMAaABpAHAALAAgAHIAZQBzAF8AZABhAHQAZQAsACAAcgBlAHMAXwBkAGUAdABhAGkAbAAsACAAcgBlAHMAXwByAG8AbABlACwAIAByAGUAcwBfAHMAYwBoAGUAbQBhACwAIAByAGUAcwBfAHMAdQBiAGoAZQBjAHQALAAgAHIAZQBzAF8AdABhAGIAbABlACwAIAByAGUAcwBvAHUAcgBjAGUALAAgAHMAdABjAF8AcwBwAGEAdABpAGEAbAAsACAAcwB0AGMAXwBzAHAAZQBjAHQAcgBhAGwALAAgAHMAdABjAF8AdABlAG0AcABvAHIAYQBsACwAIABzAHUAYgBqAGUAYwB0AF8AdQBhAHQALAAgAHQAYQBiAGwAZQBfAGMAbwBsAHUAbQBuACwAIAB0AGEAcABfAHQAYQBiAGwAZQAsACAAdgBhAGwAaQBkAGEAdABpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAcgAgAHMAYwBoAGUAbQBhACwAIABvAGIAagBlAGMAdABzACwAIABwAGgAbwB0AHAAYQByACAAZgByAG8AbQAgAHQAaABlACAAcwBhAHMAbQBpAHIAYQBsAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHMAZABzAHMAZAByADEANgAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIANwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBtAGEAawBjAGUAZAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAGUAYwBpAGUAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAG0ANAAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwB1AHAAZQByAGMAbwBzAG0AbwBzACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAGcAcgBvAHUAcABzACwAIABrAGUAeQBfAGMAbwBsAHUAbQBuAHMALAAgAGsAZQB5AHMALAAgAHMAYwBoAGUAbQBhAHMALAAgAHQAYQBiAGwAZQBzACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAXwBzAGMAaABlAG0AYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAdABlAHMAdAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABlAG4AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGcAYQBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB0AGgAZQBvAHMAcwBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAbwBzAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAdwBvAG0AYQBzAHMAIABzAGMAaABlAG0AYQAsACAAaQBjAHIAcwBjAG8AcgByACwAIABtAGEAaQBuACwAIABwAHAAbQB4AGwAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwAzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQByAGEAdAAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAbABhAHQAZQBjAG8AcgByAHMALAAgAHAAbABhAHQAZQBzACwAIABwAHAAbQB4AGMAcgBvAHMAcwAsACAAcwBwAHUAcgBpAG8AdQBzACwAIAB0AHcAbwBtAGEAcwBzAGMAcgBvAHMAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAcwBuAG8AYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdgBlAHIAbwBuAHEAcwBvAHMAIABzAGMAaABlAG0AYQAsACAAcwB0AHIAaQBwAGUAOAAyACAAZgByAG8AbQAgAHQAaABlACAAdgBsAGEAcwB0AHIAaQBwAGUAOAAyACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGQAcwBkAHMAcwAxADAAIABzAGMAaABlAG0AYQAsACAAYQByAGMAaABpAHYAZQBzACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdwBmAHAAZABiACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGkAcwBlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB4AHAAcABhAHIAYQBtAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHoAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAuAAAAN2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2luZm8AAAAQAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAAAATMjAwOS0xMi0wMVQxMDowMDowMAAAABMyMDIzLTEyLTEzVDEzOjE0OjE5AAAAAAAAAAAAAAAAAAAAAH/AAAAAAAAAAAABWGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL3RhYmxlTWV0YWRhdGE6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi9hdmFpbGFiaWxpdHk6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcDo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2V4YW1wbGVzAAAA2Gl2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvZGFsaSNleGFtcGxlcwAAAHl2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2cjp3ZWJicm93c2VyAAAASHN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OgAAADw6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta new file mode 100644 index 0000000000000000000000000000000000000000..e93eb408a38cdd1d0da405f172fe70233be10c8e GIT binary patch literal 2962 zcmds3OK;mo5H=b+cH=aT8?->t1W*qS>@cQe$$2dgPmewIXY_aUTauFE6i8AZD+u7u?7Vi~Kh6LC%ko_Md!4Mu%TjR_ zNoEB$CExuSFFM3+5;BRe2znKfRMM16M3#yKX>5&4dgM#;rK{W_?YfpqeoHpqB(IbB zJd-LAl*G$c;CW;zH}Ju;+!7E;_Jp<#y{k%aU-n3Bk`LXk-%sMz&IDJV;ub9@@{h<) zeuj8SVn_mqgZyx9m)9O16wBt0SuUuND;3$#saq_U%!*mkJo7eJFlc@^{akwz_%{os zTZKL97Rsgac44b>Z~OMWTib;PPdb|Zq80dxe6^{@A^0xVaz|IO*hk4B@-ULXdWaCDl$X@=?ySVAcUN3O1w%hL!>QLB0AWGy9n%*8B-i!2O~ zTw@ri17~JTFF_Jt*`*$jJe6_nXJmQRA!&S4(&EV1Uy*=4tGsjjR&s&@#&N5(!?HB*k1GZG(Hz=6QJ8N&NZg`;a3_S`=AmI4l%_3eZg8%?0fge9w)f)bYB^x*jTv z?A&shYyihSFBrXrYsT};4@Sx3zyAJ%qOSAsb>i4L5YKl5dz^efUYMI}*PkBN4?6el z;Auo+e7#X^KDb}qecHGVeEY@ygL#UWk?l5rewQ|isJ7l^^=(BVJp_tDHDU{y0 z%1ePf0hvcb@+N#XNlUn)ZX+2AjSy)>4C$m1mLQH!$|Sv-f|P2FLfz0Z1Khr&WO|=9 zshK%JBp^&DC|8<5W{4s8qTIqhRI{LmcGKq~6*uBT>T*9ldKTzfXv*r@}2a*qjl+1rJDW2vGJ^BND8NzjLxVY7&8&+8$PHKgUYvI zE6dz}CY^7|_&BAmuX|gdge^_tV!Gny>>bkOv$K$B;wY-NvMyA>4n4Pu-2*VTiMysuh19|uXa>nEs zE6IQ{@Jg45<@Bp)1h1rC-huK5?bhMG@$Cy7GpQ(||8sLW9R=OkF$<;MAD8g#5Gx}k zKO{1~#B_VcP}G}d;3v&UPgis_%fS-ZjF)x$VOWTiWEkH7Jhy8C27kP~ufJ`Qn3@=| z>+!rEA0T^s8A{?$XZuh*mpG9VspJi2411Ls#FRUr0LbQKwxDC$uE6dgfm>whXdLUo ot9vE!0gemIBB5E9^!z&3yFj{O#VgFh_KdEcFVD$I)Q!x40G3)C!T + The Bochum Galactic Disk Survey is an ongoing project to monitor the +stellar content of the Galactic disk in a 6 degree wide stripe +centered on the Galactic plane. The data has been recorded since +mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at +the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean +Atacama desert. It contains measurements of about 2x10^7 stars over +more than seven years. Additionally, intermittent measurements in +Johnson UVB and Sloan z have been recorded as well.{'siaarea0': <pgsphere PositionInterval Unknown 115.9428322966 -29.05 +116.0571677034 -28.95>, '_ra': 116.0, '_dec': -29.0, '_sra': 0.1, +'_sdec': 0.1, 'format0': frozenset({'image/fits', 'image/jpeg', +'application/x-votable+xml;content=datalink'})}Written by DaCHS 2.9.2 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataLegal conditions applicable to (parts of) the data containedContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceAccess key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageSurvey field observed.Effective exposure time (sum of exposure times of all images contributing here).Dataset identifier assigned by the publisherAAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBiJAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA2jAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCzWgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfrgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBe+gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEOgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCBFAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDElAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHvgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB3PAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHaAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+FwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD+DwEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgCAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjI3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJyiUsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjIyOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5ICp6IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA9ZwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBT5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEWfgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDInwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAAaAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/5BgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/98gEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2CQEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDxOgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDzKQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/k/AEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDPegEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIxVDA0OjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXMCp8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDTKwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjEzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaPXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC95gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjI0OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI3wEkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjuQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBm4wEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIxVDA0OjA1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXKJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjMxOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLC8HMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwBwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCrngEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWhgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFeQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCRxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCOnQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCenAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1dgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1egEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2vQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUkwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqNgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCN6QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6DAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCiTQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAsAAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjEzOjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaN18wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjBQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjI0OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI2O+wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKDwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjU4OjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUwi5EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkEwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjMzOjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL9uXUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjMyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLmlvIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjM3OjE0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSrAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBd7AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRRAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB2tQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/BIAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB7+wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBGBAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSfwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBxQgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkbQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBlqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6OQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHkQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjU4OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUyD+4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAH9wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBBGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhcAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCt5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjM0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJMJe0IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCoGgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjMzOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL/PdIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCREwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjMyOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCebwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjM3OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNQBhEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCI/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCpQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjU2OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZUE7i0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDK6AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjUzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRTIP7cAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgNQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjMwOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHo1niawAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBHxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjMxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLDsqIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOmQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDeawEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA4VDA0OjA1OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBXRWeIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfVAEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBTMwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCLGQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDWKAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDsqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZUgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBLSgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUbgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBR+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUyAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBsKQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjMgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9WEwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUwAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDIGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+cQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAKxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1HAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5IDCLkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKNAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjI3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJy6mIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBecwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBc3gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBdvwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+d+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB/UgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZAAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjI1OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI5pbwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjE1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FaQ4IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEZwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIxVDAzOjU3OjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUi5FAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRDwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjA2OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCsrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjE3OjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjUwOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRSBU9EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCkPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjI2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJJXOskAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaZAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjI2OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJQZykAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHlQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCQuQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC+bQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCKCwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3OAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5hQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo0gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4qAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5WAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAU+QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE2VDA2OjU1OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCS1QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0EgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqYwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBA6wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDC0gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/n+QEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAyOjQ2OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7UAYQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgYgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZLQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB11AEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDMfQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI0VDAxOjMxOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4goM5QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaCgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDN5QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBORwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBNDAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRngEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSJQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBMKwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBL0QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9IAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZ4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjI0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQl7QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBifgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcKgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfgQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjIzOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHoy/hqMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBJiAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDA4wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC66QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDLAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjI0OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQNp0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCXlAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCSwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCx8gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDjKgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDnjwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjM0OjE4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP23LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBABdgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/7fAEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/6QQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBACKgEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/9mAEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDS0QEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEJTwEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD49gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwuwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI0VDAxOjMxOjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4golKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo/wEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBunwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1pwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfJwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBf2wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCCTwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBpWQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBtvgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCEawEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBg6QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmtgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBIpwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE2VDA2OjU1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTlEpUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBx9gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBByIwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhQwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgvAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE1LTAzLTIwVDAyOjQ2OjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7ToG0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+VLgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBvrQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBPVQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB8ggEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmXAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjM0OjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP22zY8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKwwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjI5OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKdZIEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBXmAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjI1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjUwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRR/z3QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBaOwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjE3OjI2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGMtIcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjA2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXlc60AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmLwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIxVDAzOjU3OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUgncYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBYeQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjE1OjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FZgVQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBOzgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGVgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCh8wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGgwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjQ2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRQc0t4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3CwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjQ4OjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZRU9D4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCG4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCbnwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjI5OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKeJq8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdNAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjI1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI6Z+sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6
This service lets you access cutouts from BGDS images and retrieve +scaled versions.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta b/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta new file mode 100644 index 0000000000000000000000000000000000000000..2c46f1413b170e186ad1e80714a17f80aa642d24 GIT binary patch literal 1759 zcmZ`)U2o$=6fHDuLsPab1q6bX!b()_Zeu4-+oeSjDoI$nA8FKtMM6SmY)|6ZI=1T> zw@sx=>ZAN7PufH z<+dAnR6YAkF8P#rG~r5aB=kI`TyTSnBy~laP>t3Jr^g|uA!mYJ&<1mb`b}-WRyRs6 z+FV2lRkGklK|o!>q7XiXlLR5DH?cj%x$7b!A@9+oL_?g-!oHI0-3iv5VoR={hG*1M zzaTuP$puX?>131p4O0KMV_L?6VHL$C63syQAgDB#r~-68$jqs&o+v z;so^3)gaKm8xvoT@i@}?i9(&REJWij`WX>|xc&e~eOc_WfQDp1YY&j)G!O;?KS0Ek zJ8~(bLCFs$gxG_~Ju{~GhJ89_>cn}4oVSzcYB-@}OXlsV;p!xSF#y{Em|1NnG$x=X zi!gIr98lp$o|5xVnqB-)lR!z|7a~41P0uy1iEpGKEBTZmltYug;Zf7+d)z!XIV1WP z8%WGo?UPQeQrS1kpIh~kbzqb?JI6mXYh|OddEDwYPdm+ew|4TfdHVdQ-Py$WbzWvj$>X)Nv(;p)*CnU&yr|C+@+MUVCZ6wyx6NwnwU z*b|en19J4xe5iMpQ3m0-_^|-{v&9*uaft-bO~!5>!i&zBR@T~-ohh`Q(ZcH^qo*X9 z5wv8-5lV5Wi#J%TbCd$q@AnMP3%Ar;&usP11;Ts_x1*xysPkUOT8 z@_|jbJ+)}b6(9U&m$YE^E}8)(Z+p>zun@o}8IVP?(-0D6J*I_$6F$tgL;mK@tz4V! zWWk=z$xmk>r^03-L_`9d76f?Nt$gpz{g?5wZ>U-b4K}#$cX`M) zMvJ5BN5$nmTN{9uO!=+Uf%*nSxIUUzOBQU1$cEemx6xU!2$*AF4S!i^>+y6Xe~`Q- zbNT^Fe)NA@Q}X@)lADrqO77wg6V16}&2e^3N19`3Z#c;nwFpE7B<7nK9j&=osMpAt zeXbw3CFcYt3gjY7 zJ$jSJ5?qD@Te3%$Gt_m74@pAF0MiBArHOXQYkIG=R7M>^uG%g>MfUVdq;69uHU0%Z Cxuoy_ literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi new file mode 100644 index 00000000..103c4621 --- /dev/null +++ b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi @@ -0,0 +1,23 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAHGl2bzovL29yZy5nYXZvLmRjL2JnZHMvcS9zaWEAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAIYmdkcyBzaWEAAAApAEIAbwBjAGgAdQBtACAARwBhAGwAYQBjAHQAaQBjACAARABpAHMAawAgAFMAdQByAHYAZQB5ACAAKABCAEcARABTACkAIABpAG0AYQBnAGUAcwAAAAhyZXNlYXJjaAAAAgsAVABoAGUAIABCAG8AYwBoAHUAbQAgAEcAYQBsAGEAYwB0AGkAYwAgAEQAaQBzAGsAIABTAHUAcgB2AGUAeQAgAGkAcwAgAGEAbgAgAG8AbgBnAG8AaQBuAGcAIABwAHIAbwBqAGUAYwB0ACAAdABvACAAbQBvAG4AaQB0AG8AcgAgAHQAaABlAAoAcwB0AGUAbABsAGEAcgAgAGMAbwBuAHQAZQBuAHQAIABvAGYAIAB0AGgAZQAgAEcAYQBsAGEAYwB0AGkAYwAgAGQAaQBzAGsAIABpAG4AIABhACAANgAgAGQAZQBnAHIAZQBlACAAdwBpAGQAZQAgAHMAdAByAGkAcABlAAoAYwBlAG4AdABlAHIAZQBkACAAbwBuACAAdABoAGUAIABHAGEAbABhAGMAdABpAGMAIABwAGwAYQBuAGUALgAgAFQAaABlACAAZABhAHQAYQAgAGgAYQBzACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAHMAaQBuAGMAZQAKAG0AaQBkAC0AMgAwADEAMAAgAGkAbgAgAFMAbABvAGEAbgAgAHIAIABhAG4AZAAgAGkAIABzAGkAbQB1AGwAdABhAG4AZQBvAHUAcwBsAHkAIAB3AGkAdABoACAAdABoAGUAIABSAG8AQgBvAFQAVAAgAFQAZQBsAGUAYwBzAG8AcABlACAAYQB0AAoAdABoAGUAIABVAG4AaQB2AGUAcgBzAGkAdABhAGUAdABzAHMAdABlAHIAbgB3AGEAcgB0AGUAIABCAG8AYwBoAHUAbQAgAG4AZQBhAHIAIABDAGUAcgByAG8AIABBAHIAbQBhAHoAbwBuAGUAcwAgAGkAbgAgAHQAaABlACAAQwBoAGkAbABlAGEAbgAKAEEAdABhAGMAYQBtAGEAIABkAGUAcwBlAHIAdAAuACAASQB0ACAAYwBvAG4AdABhAGkAbgBzACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABvAGYAIABhAGIAbwB1AHQAIAAyAHgAMQAwAF4ANwAgAHMAdABhAHIAcwAgAG8AdgBlAHIACgBtAG8AcgBlACAAdABoAGEAbgAgAHMAZQB2AGUAbgAgAHkAZQBhAHIAcwAuACAAQQBkAGQAaQB0AGkAbwBuAGEAbABsAHkALAAgAGkAbgB0AGUAcgBtAGkAdAB0AGUAbgB0ACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABpAG4ACgBKAG8AaABuAHMAbwBuACAAVQBWAEIAIABhAG4AZAAgAFMAbABvAGEAbgAgAHoAIABoAGEAdgBlACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAGEAcwAgAHcAZQBsAGwALgAAAC9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvaW5mbwAAACwASABhAGMAawBzAHQAZQBpAG4ALAAgAE0ALgA7ACAASABhAGEAcwAsACAATQAuADsAIABGAGUAaQBuACwAIABDAC4AOwAgAEMAaABpAG4AaQAsACAAUgAuAAAAEzIwMTctMTItMDJUMDk6MTY6MDAAAAATMjAyMy0wMi0wOVQxNDozMToxMQAAAEBJZiB5b3UgdXNlIEdEUyBkYXRhLCBwbGVhc2UgY2l0ZQo6YmliY29kZTpgMjAxNUFOLi4uLjMzNi4uNTkwSGAuAAAABnN1cnZleQAAAAdiaWJjb2RlAAAAEwAyADAAMQA1AEEATgAuAC4ALgAuADMAMwA2AC4ALgA1ADkAMABIf8AAAAAAAAdvcHRpY2FsAAAB6Wh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsbWV0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsZ2V0Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL3NpYS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9CR0RTOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9iZ2RzL3Evc2lhL3NpYXAueG1sPwAAAURpdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NvZGEjc3luYy0xLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eDo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAADKdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnI6d2ViYnJvd3Nlcjo6OnB5IFZPIHNlcDo6OnZzOnBhcmFtaHR0cAAAAH5zdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjpzdGQAAABpOjo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6AAAAAA==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta new file mode 100644 index 0000000000000000000000000000000000000000..ce5bfe96cb3608de1fe46fb28b8ac0542e94dc10 GIT binary patch literal 2900 zcmd^BNpIUm6gC<;cB3?o8?->t1W*qS>?oqPY)X-XD$Cgv$&uuwITV8-IU*TTBr`LV ztO5a=OHl*7mA&=H^w?j~-_mbLO0rWRO?|B(fbYF|+q`vt%Ki2@zmojk#@kU|NGd}? z4Buq&(?6p%n^BW-5l2@zdlNDtg(f5q4He8M<@K?YpgrL9MUa!qS!wSt^FLNfCu)62DrR@W*@CTCI!hjP2g=h`#hyIH8* zF6=SAP^;8#6{_|7)$0A*cM1=m4Hf@I!}lcfWJ%5f$X#q@=rBRQqCwy~22~d;AC)G) zq`J$BM`IVVq0pnXENF4`#XNju>>G#Lf_{bc)42BZ*ND(Q_m5`t0B%R?WWl&GSD=lN z8y9ih*yk*u2xO*VDRzF$r0tuy=YDT6jH7cQcjM@)EoE@OT;|NuEI6zA+$u{Nl*P<5 zV*3+&HA$PjZs&JYPA-H9aEV&DejHsmP)IXH?gq0Ly>eB%qnT_{uNSSxE&bjtR@Y1w z#7Yej-Jih&uUyxvRpes3<9OlGj*938H4GNW6M5cfrj%utH?1F?;AX*OBNutPSS{nI$Ttc9e0!}JaRlqu0$v<>duUuYaa6#J4QYTso(-X>Ubc0oe?rkB=pd9&d5=v4hvsq$DTNSavWV=o@C0Nu0&Ut zM8PC+Jd6$M!kX*iX2;Rzr_Te5EGbpYz`!8^_oa_vf@rR)px}FMDul|{Wum+2EM{h& zi+Be#>bm~)1g#t8i04n^C%^yo2Mcxk(c9QIGbGCCzB!A(|8{j{rQd#j&>jpQnEvyS z@!9oGv-|KtbN6}YI_UjZ4+iZ{yEWXZG@Xg>m|L}05#x}kA)#Pl`&<%_juR|7aip6d zSpgE4O_)2EGnp{B6R0tgk}wESMvS1G6v5z(Vv-WU-Yig-SPcU;&{78+%a$TJPlwdf z9Y5qyrV5lw#UN6`gt}qop#{^#A7R{Blqc$@bi#D%B{1$;EaIk^=NzM%P|Mn?-D~xl zo%W#B2BLw`zBje?!?)P`#P{gIV!KuP9isprm}o=AgJ#k=)^5O=3}bCVVAn z_|IhXgpQ9h>UeUr2jcw- zab$R}-+P7+=h%m7O#^(tF%3f(uHi?zoPeeV7kHW_&~q z_F=Yv`1A5nyWfTkDmv}!`YtXHP}OT~4}Yvo&7#aFN|aW_=^5i`lK@r>(6 zc{M-?o-|SrEMOq6qiet+ALaMex6cIj9+u>Glv4`;Y$u;HarEi(MH8*Wc4&t(euphV z-lPr@>5Q2VVt2kBF!M}@ +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta new file mode 100644 index 0000000000000000000000000000000000000000..b93b2561993f739d8f2a613ff6f2c37e69569146 GIT binary patch literal 3088 zcmb^zOK;mYIM|XVbCRZ6u>r$cfYYT(8%ehFPVE$K?6zqgJGGs5I}8FP(iR(8Qbj6` z3lvx{!wTp&?YRH4<9@>q`z`w@$#&8`x9Epb~n3IX!eabvYC4j8>T?;-BNyck$aex@K_U z1vHN4EzfbNC79;|&3rQemXwTeTOfB?1lZ+W8mQC-+05<5(Q;=5tBql^mL0mMl*B&* zdrpHh8o;5Q9d1|g!IQRL)ONKZ5(CBsB`>L|7xUV>mX|cs1Pf4Tx|;lMA9?N?%5S1a z)I`O6aRU|B_X>r*&29Afs3Y+gEYB6x6{;BeK(}y^T|3G3EA0CYv#>NwKUdE@flY_r zJMTL{8*($6&72lTUyR&m^gZiT8^doJt<YgXY1?tdb=Cu&IVoAh;(AU z2p&Bif(EX>t`!Opi~0skCf%`i3tM>; z1jzK5gF5q0nJlCm#JbW`t%+76EM$Y9A`xAYLCc z7XV*pfQ*w7x=@j<%VZsZgfFvamtTH)AKjR|WXzsTMYkqEPKCi-=qcC%X^sPyy^lV> z{O)52p=3oZ=thPgc*28D1KymGPJ#cY1I}eIZy2TnWk*S-IgeKXh8@QnT!1yAX~Xpf z@zY=b{EddD{p4+Ilk5^rn;sd)5C52%no`w|#dlFAVbV9MjQgJKjh?%QE~JW!`?RdI zYR^wfy>`$+?95|i4Fyyd zEHN0#p%1=Ct>zI50_c2zA_sxZ{J$X~^t5@{K+u$o(04pcG)6e8w2?!*LLQq9w35gw zXAnSG{r_wN*0aZaCd!sa@PFj?@=2{#OHIr4HsmxY-(ftNK*Sv0xun8XdivzJ-mFv; zSA+d)&~b2o4^CGp1K26|QI|neOtMnmWk!}Bz$8OZ&>ZY8D+MjDpwW0PE1~GBJIaIo zTaJ`a4F&^kL?A~JQdMC3qS>iD ztk*_#Qv8O3Kp~fxl?#-R4OoMgrNfgBM6&bfX9aCNL*6^*>=MCXJsEt(e7>N6dsJ^* zHtl1Txv=@T76mHK_ILuUd+BJuMEZO`iE1gQpDb;^+2ZLIf3^-QzK@V6)AmCaL!!klF-Ru#rzt%a!B^?mbB!Oc_1}B*j zV~(InCMYxDm}8uwxl=A>alq4{&jqslgrSqxoa`ZzaKn8NL!t%Ul7pi>p{1 zeKy&~qN&&p?NG$;V2By7Q-ut{`qTqpV>G;AJtQoE&4&YQ)<|aWP)>H(yaS5+aGWtL e8c32kIUvvFvXSg}(UM`o?rw}%_xOEihT302gCvIl literal 0 HcmV?d00001 diff --git a/pyvo/registry/rtcons.py b/pyvo/registry/rtcons.py index 1ea1f5bf..5038cd9d 100644 --- a/pyvo/registry/rtcons.py +++ b/pyvo/registry/rtcons.py @@ -1027,7 +1027,7 @@ def build_regtap_query(constraints, service): extra_tables |= set(constraint._extra_tables) joined_tables = ["rr.resource", "rr.capability", "rr.interface" - ] + list(extra_tables) + ] + list(sorted(extra_tables)) # see comment in regtap.RegistryResource for the following # oddity diff --git a/pyvo/utils/testing.py b/pyvo/utils/testing.py index e9e13434..b3e11115 100644 --- a/pyvo/utils/testing.py +++ b/pyvo/utils/testing.py @@ -41,6 +41,7 @@ def create_dalresults( The arguments are as for create_votable. """ + return resultsClass( create_votable(field_descs, records), url="http://testing.pyvo/test-url") From 3eac8e4aae308912cc5c7fb7b83ef25c88cbe3b6 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 5 Feb 2024 14:58:12 +0100 Subject: [PATCH 10/38] Minor fix in SIA1 branch of global image discovery --- pyvo/discover/image.py | 5 +++-- pyvo/discover/tests/test_imagediscovery.py | 20 +++++++++----------- 2 files changed, 12 insertions(+), 13 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 8b5aafdb..1019eb6b 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -287,9 +287,10 @@ def _query_one_sia1(self, rec: Queriable): """ def non_spatial_filter(sia1_rec): if self.spectrum and not self.inclusive and ( - sia1_rec.bandpass_hilmit and sia1_rec.bandpass_lolimit): + sia1_rec.bandpass_hilimit is not None + and sia1_rec.bandpass_lolimit is not None): if not (sia1_rec.bandpass_lolimit - <= self.spectrum + <= self.spectrum*u.m <= sia1_rec.bandpass_hilimit): return False diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 6e667ec6..c82fbbcb 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -15,12 +15,6 @@ from pyvo.utils.testing import LearnableRequestMocker -@pytest.fixture -def _all_constraint_responses(requests_mock): - matcher = LearnableRequestMocker("image-with-all-constraints") - requests_mock.add_matcher(matcher) - - @pytest.fixture def _sia1_responses(requests_mock): matcher = LearnableRequestMocker("sia1-responses") @@ -49,21 +43,25 @@ def test_single_sia1(_sia1_responses): assert "dc.zah.uni-heidelberg.de/getproduct/bgds/data" in im.access_url +@pytest.fixture +def _all_constraint_responses(requests_mock): + matcher = LearnableRequestMocker("image-with-all-constraints") + requests_mock.add_matcher(matcher) + + def test_cone_and_spectral_point(_all_constraint_responses): images, logs = discover.images_globally( space=(134, 11, 0.1), spectrum=600*u.eV) - assert ("SIA2 service : 8 recs" + # TODO: this needs to be the obscore service when we have fixed + # obscore discovery + assert ("SIA2 GAVO Data Center SIAP Version 2 Service: 8 records" in logs) assert len(images) == 8 assert images[0].obs_collection == "RASS" - # expected failure: the rosat SIA1 record should be filtered out - # by its relationship to the sitewide SIA2 - assert len(logs) == 1 - @pytest.fixture def _servedby_elision_responses(requests_mock): From 9f8559587fcd1436157c83758b3a480fc1202c70 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 6 Feb 2024 11:41:31 +0100 Subject: [PATCH 11/38] Adding an obscore_new data model to the registry Datamodel constraint. This is a temporary measure until we have moved the VO to a saner obscore registration (i.e., obscore_new). When the Registry shows everyone has moved, obscore_new should become obscore, and the current obscore probably just dropped. --- pyvo/registry/rtcons.py | 16 +++++++++++++++- pyvo/registry/tests/test_rtcons.py | 9 ++++++++- 2 files changed, 23 insertions(+), 2 deletions(-) diff --git a/pyvo/registry/rtcons.py b/pyvo/registry/rtcons.py index 5038cd9d..741897c8 100644 --- a/pyvo/registry/rtcons.py +++ b/pyvo/registry/rtcons.py @@ -519,11 +519,17 @@ class Datamodel(SubqueriedConstraint): one of several well-known data models; the SQL produced depends on the data model identifier. + Records returned with these constraints will have a TAP (or + auxiliary TAP) capability. + Known data models at this point include: * obscore -- generic observational data * epntap -- solar system data * regtap -- the VO registry. + * obscore-new -- the table-based new-style obscore discovery. Don't + use in code built to last: this will become normal obscore + when we have migrated the VO. DM names are matched case-insensitively here mainly for historical reasons. @@ -532,7 +538,7 @@ class Datamodel(SubqueriedConstraint): # if you add to this list, you have to define a method # _make__constraint. - _known_dms = {"obscore", "epntap", "regtap"} + _known_dms = {"obscore", "epntap", "regtap", "obscore_new"} def __init__(self, dmname): """ @@ -557,6 +563,14 @@ def _make_obscore_constraint(self): "detail_xpath = '/capability/dataModel/@ivo-id'" f" AND 1 = ivo_nocasematch(detail_value, '{obscore_pat}')") + def _make_obscore_new_constraint(self): + self._extra_tables = ["rr.res_table"] + return ("table_utype like 'ivo://ivoa.net/std/obscore#table-1.%'" + # Only use catalogresource-typed records to keep out + # full TAP services that may have the table in their + # tablesets. + " AND res_type = 'vs:catalogresource'") + def _make_epntap_constraint(self): # we include legacy, pre-IVOA utypes for matches; lowercase # any new identifiers (utypes case-fold). diff --git a/pyvo/registry/tests/test_rtcons.py b/pyvo/registry/tests/test_rtcons.py index ab8744f5..543d0f7c 100644 --- a/pyvo/registry/tests/test_rtcons.py +++ b/pyvo/registry/tests/test_rtcons.py @@ -215,7 +215,14 @@ def test_junk_rejected(self): with pytest.raises(dalq.DALQueryError) as excinfo: rtcons.Datamodel("junk") assert str(excinfo.value) == ( - "Unknown data model id junk. Known are: epntap, obscore, regtap.") + "Unknown data model id junk. Known are: epntap, obscore, obscore_new, regtap.") + + def test_obscore_new(self): + cons = rtcons.Datamodel("obscore_new") + assert (cons.get_search_condition(FAKE_GAVO) + == "table_utype like 'ivo://ivoa.net/std/obscore#table-1.%'" + " AND res_type = 'vs:catalogresource'") + assert (cons._extra_tables == ["rr.res_table"]) def test_obscore(self): cons = rtcons.Datamodel("ObsCore") From 42e1282c4cac76314010ff1839e3a8844f35b526 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 8 Feb 2024 13:58:43 +0100 Subject: [PATCH 12/38] New datamodel obscore-new to locate obscore tables. In global image discovery, using this to elide TAP services. Updating test data. --- pyvo/discover/image.py | 45 +- ...ni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS | 28 -- ...idelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta | Bin 1756 -> 0 bytes ...i-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ | 18 - ...delberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta | Bin 1851 -> 0 bytes .../GET-reg.g-vo.org-capabilities-VYcr5usI | 2 +- ...ET-reg.g-vo.org-capabilities-VYcr5usI.meta | Bin 1504 -> 1504 bytes .../GET-reg.g-vo.org-tables-Mffx+yRe | 473 +++++++++--------- .../GET-reg.g-vo.org-tables-Mffx+yRe.meta | Bin 1431 -> 1431 bytes ...ah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 | 17 + ...i-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta | Bin 0 -> 1888 bytes .../POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD | 6 +- ...ST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta | Bin 3153 -> 3153 bytes .../POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS | 28 ++ ...ST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta | Bin 0 -> 3250 bytes ...> POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU} | 2 +- ...T-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta} | Bin 3168 -> 3249 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ | 8 +- ...ST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta | Bin 3163 -> 3163 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr | 6 +- ...ST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta | Bin 3287 -> 3287 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill | 2 +- ...ST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta | Bin 3161 -> 3161 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg | 8 +- ...ST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta | Bin 2962 -> 2962 bytes pyvo/discover/tests/test_imagediscovery.py | 5 +- 26 files changed, 340 insertions(+), 308 deletions(-) delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y => POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU} (87%) rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta => POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta} (72%) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 1019eb6b..caa70f5d 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -196,7 +196,6 @@ def ids(recs): # IsServedBy relationship to another service we will also # query. That's particularly valuable if there are large # obscore services covering data from many SIA1 services. - ids_present = table.Table([ table.Column(name="id", data=list( @@ -205,6 +204,7 @@ def ids(recs): | ids(self.obscore_recs))), description="ivoids of candiate services", meta={"ucd": "meta.ref.ivoid"}),]) + services_for = regtap.get_RegTAP_service().run_sync( """SELECT ivoid, related_id FROM rr.relationship @@ -212,7 +212,6 @@ def ids(recs): JOIN tap_upload.ids AS rightids ON (related_id=rightids.id) WHERE relationship_type='isservedby' """, uploads={'ids': ids_present}) - for rec in services_for: self._log(f"Skipping {rec['ivoid']} because" f" it is served by {rec['related_id']}") @@ -222,6 +221,34 @@ def ids(recs): self.sia2_recs = _clean_for(self.sia2_recs, collections_to_remove) self.obscore_recs = _clean_for(self.obscore_recs, collections_to_remove) + def _discover_obscore_services(self, *constraints): + # For obscore, we currently have a defunct discovery pattern + # ("obscore" in the Datamodel constraint). There is obscore-new, + # which fixes the problem, but until that's adopted by all the + # obscore services, we have to try both and the pick the + # more suitable version. + # Once we move obscore-new to obscore, remove this function + # and put + # self.obscore_recs = [Queriable(r) for r in registry.search( + # registry.Datamodel("obscore"), *constraints)] + # back into discover_services. + obscore_services = registry.search( + registry.Datamodel("obscore_new"), *constraints) + tap_services_with_obscore = registry.search( + registry.Datamodel("obscore"), *constraints) + + new_style_access_urls = set() + for rec in obscore_services: + new_style_access_urls |= set( + i.baseurl for i in rec.list_services("tap")) + + for tap_rec in tap_services_with_obscore: + access_urls = set( + i.baseurl for i in rec.list_services("tap")) + if new_style_access_urls.isdisjoint(access_urls): + obscore_services.append(obscore_services) + + return [Queriable(r) for r in obscore_services] def discover_services(self): """fills the X_recs attributes with resources declaring coverage @@ -250,8 +277,7 @@ def discover_services(self): registry.Servicetype("sia"), *constraints)] self.sia2_recs = [Queriable(r) for r in registry.search( registry.Servicetype("sia2"), *constraints)] - self.obscore_recs = [Queriable(r) for r in registry.search( - registry.Datamodel("obscore"), *constraints)] + self.obscore_recs = self._discover_obscore_services(*constraints) self._purge_redundant_services() @@ -366,8 +392,8 @@ def _query_one_obscore(self, rec: Queriable, where_clause:str): """ self._info("Querying Obscore {}...".format(rec.title)) svc = rec.res_rec.get_service("tap") - recs = svc.query("select * from ivoa.obscore"+where_clause) - matches = ImageFound.from_obscore_recs(recs) + recs = svc.run_sync("select * from ivoa.obscore "+where_clause) + matches = list(ImageFound.from_obscore_recs(recs)) self._log("Obscore {}: {} records".format( rec.title, @@ -382,8 +408,11 @@ def _query_obscore(self): where_parts = ["dataproduct_type='image'"] # TODO: we'd need extra logic for inclusive here, too if self.center is not None: - where_parts.append("distance(s_ra, s_dec, {}, {}) < {}".format( - self.center[0], self.center[1], self.radius)) + where_parts.append( + "(distance(s_ra, s_dec, {}, {}) < {}".format( + self.center[0], self.center[1], self.radius) + +" or 1=intersects(circle({}, {}, {}), s_region))".format( + self.center[0], self.center[1], self.radius)) if self.spectrum is not None: where_parts.append( f"(em_min<={self.spectrum} AND em_max>={self.spectrum})") diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS deleted file mode 100644 index f48359c7..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS +++ /dev/null @@ -1,28 +0,0 @@ - - -ROSAT was an orbiting x-ray observatory active in the 1990s. -We provide a table of all photons observed during ROSAT's all-sky -survey (RASS) as well as images of both survey and pointed observations. - -For ROSAT data products, see -http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-survey{'siaarea0': <pgsphere PositionInterval Unknown 133.9490641653 10.95 -134.0509358347 11.05>, '_ra': 134.0, '_dec': 11.0, '_sra': 0.1, -'_sdec': 0.1, 'format0': frozenset({'image/fits', 'image/jpeg', -'application/x-votable+xml;content=datalink'})}Written by DaCHS 2.9.2 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceMetadata for ROSAT pointed observations and the ROSAT All Sky Survey -(RASS) images -Codes used here include: - -=== ============================================================== -im1 photon image in the broad band (0.1-2.4 keV) -im2 photon image in the hard band (0.4-2.4 keV) -im3 photon image in the soft band (0.1-0.4 keV) -ime image of the average photon energy -bk1 background image in the broad band (0.1-2.4 keV) -bk2 background image in the hard band (0.4-2.4 keV) -bk3 background image in the soft band (0.1-0.4 keV) -mex merged map of exposure times for the broad band (0.1-2.4 keV) -=== ==============================================================Access key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageROR sequence numberNumber of follow-up observation (0=first observation, NULL=mispointing)Type of data in the file (associated products available through datalink of by querying through seqno)Publisher dataset identifier (this lets you access datalink services and the like)Link to a datalink document for this dataset, this lets you access associate data)AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAANB2QGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtPhEKTkf/+mw+SqAaWYHPGD4BwBGVzv0pAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltMQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAYbVAYIY18QtAHkAmfLF9ZpfuAAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABJST1NBVCBNZWRpdW0gWC1SYXkAAAABbT4ObdT//buEPiqgGmC2e70+AcARlc79KQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAACmltYWdlL2ZpdHMAAKUnQGCGNfELQB5AJnyxfWaX7gAAADdST1NBVCBQU1BDQyBST1NBVCBTb2Z0IFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAC1JPU0FUIFBTUENDQOeG6tdfMa8AAAACAAAAAgAAAgAAAAIAAAAAAj+JmZmZmZmaP4mZmZmZmZoAAAAESUNSU0T6AABUQU4AAAACQHAIRD1GsmxAcAhEPUaybAAAAAJAYIYAAAAAAEAmgAAAAAAAAAAABL+JmZmZmZmaAAAAAAAAAAAAAAAAAAAAAD+JmZmZmZmaAAAAEFJPU0FUIFNvZnQgWC1SYXkAAAABbT41TOHhNKWsPkqgGlmBzxg+KqAaYLZ7vQAAAAFGAAAACEBg7PUzlqZ1QCAX9w8UJRpAYO9C80BS6EAs1brvyx9AQGAcwI6BlEdALNW7ttx5ZEBgHw46msmPQCAX93yMzl0ADjbEAAAAAAAAAANpbTMAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAqmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvcm9zYXQvcS9kbC9kbG1ldGE/SUQ9aXZvJTNBJTJGJTJGb3JnLmdhdm8uZGMlMkZ+JTNGcm9zYXQlMkZpbWFnZV9kYXRhJTJGcmRhXzglMkZ3ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMSUyRnJzOTMxNTI0bjAwX2ltMy5maXRzLmd6AAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltZS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAUTpQGCGNfELQB5AJnyxfWaX7gAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAAtST1NBVCBQU1BDQ0DnhurXXzGvAAAAAgAAAAIAAAIAAAACAAAAAAI/iZmZmZmZmj+JmZmZmZmaAAAABElDUlNE+gAAVEFOAAAAAkBwCEQ9RrJsQHAIRD1GsmwAAAACQGCGAAAAAABAJoAAAAAAAAAAAAS/iZmZmZmZmgAAAAAAAAAAAAAAAAAAAAA/iZmZmZmZmgAAABdST1NBVCBTb2Z0L01lZGl1bSBYLVJheQAAAAFtf/gAAAAAAAB/+AAAAAAAAH/4AAAAAAAAAAAAAUYAAAAIQGDs9TOWpnVAIBf3DxQlGkBg70LzQFLoQCzVuu/LH0BAYBzAjoGUR0As1bu23HlkQGAfDjqayY9AIBf3fIzOXQAONsQAAAAAAAAAA2ltZQAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3oAAACqaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2RsL2RsbWV0YT9JRD1pdm8lM0ElMkYlMkZvcmcuZ2F2by5kYyUyRn4lM0Zyb3NhdCUyRmltYWdlX2RhdGElMkZyZGFfOCUyRndnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxJTJGcnM5MzE1MjRuMDBfaW1lLmZpdHMuZ3o=
Datalink service for ROSAT images. This gives access to images in the -various bands, background maps, and other ancillary data. - -For more detailed information on the various data products, please -refer to http://www.xray.mpe.mpg.de/rosat/archive/docs/rdf.ps.gz
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap.xml-rmZQRU14Am3yI+JS.meta deleted file mode 100644 index 038d2943e66e155a151510b131cf6b5e98fb3a5c..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1756 zcmZ`)U2o$=6fHDuLsPab1q6bX!b()>Zeu4-yU?Ntl_V_Pk2Gq+A|W9&wkPpy9ozMc z+on<__61RC-WdK5kG%3H_#K={oTMv39x^j$?!7Z}&pp?_@T_EQ{vHtE4h`>^OSPI4K9+@6=^~>+8~@Bhn$9-33fr7%oXZ)wewotD7kEN z5hYZ~f*S<^bp?w;_!LeOgrwfo_7vxCiiCu`Pm?kYaW)GFN^bV1SZju@xPBU*QBVDf z@SG+WG{K~sP3|{Iis|+)2bLXqoRFs9uc@ut~nm=zlg%!Vr9Sh zEp>`k#o8-YYlnOLhd`dZ=xO^kHwpy}MOlnu_^mavWpBLvn8b0wT%sRlUX?E*L7ad- zx*7)BcWdhFF&;-cKT)VNmW62EML#1#5Z52#sIQ8B7SNCkY5f6moCd-`;0K79a!0OY zG${GOln{Fuxo5@<-?C39Or1Edkn>IwU5%!clw{tX8Lm$Q7(=iffSL79LSq7IvIujx zQLP%4?e6i9t$M|%ZXdUMtU6g;ep9!U|F*w0 zE-63n7j|^LtfnBpOa{o8lB?hA#nEK(MLc?WVpfgExWGlN_Goah=X|+GYlf!@u2|r< zGs0U!vu5CYt5|x@!t`oKGqz4#m&W2w4Xz(eka-1e4z5|eTl8o@Kn?8{okV*sPdqW1 zI3Pt2&4+qt6;%*UY99-bKVO_t8kb1`*}zbfn}_bAGp2>LF(YRNZDy?S#@Og7N#^{l z*l~nP94UEElVVJqUcp3eHEExqiY8v2iCHF5)I&%GcL|F7H`G?&wGJNdt6QiY(`x0w zCfuG`wB?!)db3MfFnbrh0E)N0Xh>KH;FAoW7#Y@gLDI2yE zKs40LZqC&XFcJjO_iSwdS~B6cQ_b&?2-io?YRiHR4cSne;5Hfy76Ee%tl=*U9X+0o)en+OGN&J) z~sCL zl3YX(yi2Z*wY#gsC?az@l7<%{V65Mn1=L`E8dO{AxEg%RQY1wt1RK&Q705)Ecr+%D yCAbR*wqlR#W~8eUUy+28A*M^VOB3yq*W_Mlp^W>1T(@0(hwRyBNZqDRYWxdOz@#Jq diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ deleted file mode 100644 index 9fee67c4..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ +++ /dev/null @@ -1,18 +0,0 @@ - -Definition and support code for the ObsCore data model and table.{'pos0': <pgsphere Circle Unknown 134. 11. 0.1>, 'BAND0': -2.0664033072200047e-09}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. -The calib_level flag takes the following values: - -=== =========================================================== - 0 Raw Instrumental data requiring instrument-specific tools - 1 Instrumental data processable with standard tools - 2 Calibrated, science-ready data without instrument signature - 3 Enhanced data products (e.g., mosaics) -=== ===========================================================High level scientific classification of the data product, taken from an enumerationAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.AAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6AAAAPlJPU0FUIFBTUENDIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9iazEuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAADLAAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAVgAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTEuZml0cy5negAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAANAAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+SqAaWYHPGH/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQyBST1NBVCBNZWRpdW0gWC1SYXkgMTk5MC0xMC0xOSAwODowNzo1MS41MDAwMTIAAABjaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMi5maXRzLmd6AAAAAAAAAHpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABgAAAAAAAAAAEBghjXxC0AeQCZ8sX1ml+5AGZmZmZmZmgAAAH5Qb2x5Z29uIElDUlMgMTM1LjQwNDkzMTgyNTkgOC4wNDY4MDY3ODQ4IDEzNS40NzY5MjI2MzE5IDE0LjQxNzQ0MTgzODggMTI4Ljg5ODUwNTQ1MjIgMTQuNDE3NDQ3NzcxNSAxMjguOTcwNDg2OTI5MiA4LjA0NjgxMDA0NzNARoAAAAAAAEDnhurXXzGvQOeG6tdfMa9/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENDAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0BGgAAAAAAAAAAAAAAAAIdodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWUAAAAFaW1hZ2UAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAADwAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazEuZml0cy5negAAAD5ST1NBVCBQU1BDQiBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkzLTA0LTI1IDE3OjI3OjQzLjEyOTk5NgAAAFtpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6AAAAAAAAAHJodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAbAAAAAAAAAABAYJtFRGOCNEAnp9uUMZwPQAERERoDt0UAAAB+UG9seWdvbiBJQ1JTIDEzMy45MzM0MTYyMTA0IDEwLjc2MzU5MDAwMTEgMTMzLjk0MTg3OTk4OTIgMTIuODkyMTI4MzMxOSAxMzEuNzU4Mjc0Mzg1IDEyLjg5MjEyODkyMiAxMzEuNzY2NzM3MDYwNyAxMC43NjM1OTA0OTEyQC4AACGN70FA5/nXSFskwkDn+ddIWyTCf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQgAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ALgAAIY3vQQAAAAAAAAB/aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAVpbWFnZQACAAAABFJBU1MAAABHcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAA5Uk9TQVQgUFNQQ0IgUk9TQVQgTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazIuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABUAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPiqgGmC2e71/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAABWltYWdlAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQiBST1NBVCBNZWRpdW0gWC1SYXkgMTk5My0wNC0yNSAxNzoyNzo0My4xMjk5OTYAAABbaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAAAAAAAByaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAIAAAAAAAAAAAQGCbRURjgjRAJ6fblDGcD0ABEREaA7dFAAAAflBvbHlnb24gSUNSUyAxMzMuOTMzNDE2MjEwNCAxMC43NjM1OTAwMDExIDEzMy45NDE4Nzk5ODkyIDEyLjg5MjEyODMzMTkgMTMxLjc1ODI3NDM4NSAxMi44OTIxMjg5MjIgMTMxLjc2NjczNzA2MDcgMTAuNzYzNTkwNDkxMkAuAAAhje9BQOf510hbJMJA5/nXSFskwn/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0IAAAAAAAACAAAAAAAAAAIA////////////////////////////////QC4AACGN70EAAAAAAAAAf2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWU=
A datalink service accompanying obscore. This will forward to data -collection-specific datalink services if they exist or return -extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-dc.zah.uni-heidelberg.de-siap2.xml-qi17FyiuVbxvuUzJ.meta deleted file mode 100644 index a5fd051a9852fbe3080ee050b528fa8ac4b10497..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1851 zcmb7FU2o$=6s>6bp{8tGszo4J$*d4+w~gaCX-kVLRFY-c-EJDS1)k6_wkNf>&e-c2 zx6MkG*cU{lc|cmX(PdeMahx6TGp$xmN502n-<%)j{G0{) zXOtH#yI>g>C&l7Hi#ESGsk-*A?OO6O5|RbqGq378cHMSNPAQ-g7b>*|e-B~4I+^yrauWc9V<$-ZhJqWQc^$c;ixaHZWJ?4du;z9dYs47M&XC3mxC0G3sBx`D(j02ZO1?(Qsj)BZlCu1oEG)09; z+H8->FbTApe)9Mf&peB@`Zbg?-K$mu-+oO)JLgd)WD!bvEIYFURwYFAfkBUus)%Un z;wjlBB8H}oMt#{iI@xbNJ#HR8-l)|ZwzE;I;o;b|&%QcnxAtAz+1_qA^}4g;x{l*C zc38#P-MHJW!*{}&0r$fBu)J=FwUC1)6?%roYPImKF%E{tPTK$Os9LkPanp->edBDm z;eFmt?n80>|xSNgs9aP>r&8dnAI7E64%(Q=K)1y52zuHWteuK`ESEdPT zY8uti0Cj(O0!A;?ZyEJlP`{>V91bxNmAln$-R;&iNB?BhV@WR2zXC4Iy&%e -http://dc.zah.uni-heidelberg.de/taphttps://dc.zah.uni-heidelberg.de/tapGloTS 1.0Obscore-1.1Registry 1.1ADQL2.02.1The Astronomical Data Query Language is the standard IVOA dialect of SQL; it contains a very general SELECT statement as well as some extensions for spherical geometry and higher mathematics.
gavo_apply_pm(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmde DOUBLE PRECISION, epdist DOUBLE PRECISION) -> POINT
Returns a POINT (in the UNDEFINED reference frame) for the position +http://dc.zah.uni-heidelberg.de/taphttps://dc.zah.uni-heidelberg.de/tapGloTS 1.0Registry 1.1Obscore-1.1ADQL2.02.1The Astronomical Data Query Language is the standard IVOA dialect of SQL; it contains a very general SELECT statement as well as some extensions for spherical geometry and higher mathematics.
gavo_apply_pm(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmde DOUBLE PRECISION, epdist DOUBLE PRECISION) -> POINT
Returns a POINT (in the UNDEFINED reference frame) for the position an object at ra/dec with proper motion pmra/pmde has after epdist years. positions must be in degrees, PMs in should be in julian years (i.e., proper diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta index d978c1a5e562b37e76ea5e370dd217a4cc2f09d0..369a6ea55dc58fd4c56f73d1bdadb1cc93a8aff9 100644 GIT binary patch delta 84 zcmaFB{eXMIKZ%fxQXK^Y3kA2-Bn2Y_BNGKfBP&xgD}&8qj0ub)rrPNyMiwb%24;FG lAXx(=1B=aFOh!xsndgtBmL_Gm)K1Ar@B(r+pJ5SU1OO8z8Sel9 delta 84 zcmaFB{eXMIKMCLbJRJoCQw6uwBn2Y_BNGKfV=EIAE7Q$lj0ub)#@gwYCP@}1sm6LK lAXx(=1Jli2Oh!xs(a#Q~mL_Gm)K1Ar@B(r+pJ5SU1OOQM8X^Dy diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe index 31eebf43..328bc1b8 100644 --- a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe +++ b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe @@ -81,12 +81,12 @@ comparable to what has been done to construct the FK* series of fundamental catalogs. About 7e6 published positions are included. In GAVO's DC, we provide tables of identified and non-identified stars -together with the master catalog that objects were identified against.arigfh.masterThe master catalog against which all ARIGFH historical observations -were matched.612627catnoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintindexedprimaryraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoubleindexednullablepmraMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdeMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecomponentComponent designation in a multiple system in the master catalogmeta.code.multipcharnullable
arigfh.identifiedMatches between the master catalog and the historical catalogs.6300000distOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullablemasternoCatalog number in master catalog (arigfh.master)meta.id;meta.mainintindexeddcompComponent designation for multiple system, as in the master catalogmeta.code.multipcharnullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcsortCatalog typemeta.codeshortcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexedcatanObject number in source catalog, ARI assignedmeta.idintindexed
arigfh.unidentifiedThe objects in the gfh table that could not be matched with objects in -the master catalog by ARIGFH.872720catanObject number in source catalog, ARI assignedmeta.idintindexedcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexed
arigfh.gfhThe table of (almost) all objects read from the catalogs, together +together with the master catalog that objects were identified against.
arigfh.gfhThe table of (almost) all objects read from the catalogs, together with most of the data given in them.7100000catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharindexednullablecatanObject number in source catalog, ARI assignedmeta.idintindexedcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoubleindexednullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoubleindexednullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.id The stars from the gfh table having counterparts in the master -catalog, together with those counterparts.masternoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintcompmasterComponent designation in a multiple system in the master catalogmeta.code.multipcharnullableraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoublenullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoublenullablepmramasterMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdemasterMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvmasterVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembmasterBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecatidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintdistOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.nid The stars from the gfh table that could not be matched with objects -in the master catalog.catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arihipARIHIP astrometric catalogue The catalogue ARIHIP has been constructed by selecting the 'best +catalog, together with those counterparts.masternoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintcompmasterComponent designation in a multiple system in the master catalogmeta.code.multipcharnullableraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoublenullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoublenullablepmramasterMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdemasterMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvmasterVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembmasterBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecatidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintdistOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullablearigfh.identifiedMatches between the master catalog and the historical catalogs.6300000distOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullablemasternoCatalog number in master catalog (arigfh.master)meta.id;meta.mainintindexeddcompComponent designation for multiple system, as in the master catalogmeta.code.multipcharnullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcsortCatalog typemeta.codeshortcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexedcatanObject number in source catalog, ARI assignedmeta.idintindexed
arigfh.masterThe master catalog against which all ARIGFH historical observations +were matched.612627catnoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintindexedprimaryraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoubleindexednullablepmraMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdeMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecomponentComponent designation in a multiple system in the master catalogmeta.code.multipcharnullable
arigfh.nid The stars from the gfh table that could not be matched with objects +in the master catalog.catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.unidentifiedThe objects in the gfh table that could not be matched with objects in +the master catalog by ARIGFH.872720catanObject number in source catalog, ARI assignedmeta.idintindexedcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexed
arihipARIHIP astrometric catalogue The catalogue ARIHIP has been constructed by selecting the 'best data' for a given star from combinations of HIPPARCOS data with Boss' GC and/or the Tycho-2 catalogue as well as the FK6. It provides 'best data' for 90 842 stars with a typical mean error of 0.89 mas/year @@ -100,26 +100,33 @@ stars).90842auger.main Detection parameters of cosmic ray source candidates recorded by the Pierre Auger Telescope. This table can be queried on the web at -http://dc.g-vo.org/auger/q/cone/form .28493eventidAuger event numbermeta.id;meta.maincharraj2000Incoming cosmic ray direction, RAdegpos.eq.ra;meta.mainfloatdej2000Incoming cosmic ray direction, Declinationdegpos.eq.dec;meta.mainfloatnstatNumber of stations participating in an eventmeta.number;obsshortcreReconstructed energy of the cosmic ray particleEeVphys.energyfloatmjdObservation time, Modified Julian Daytime.epoch;obsfloatgallonGalactic longitudedegpos.galactic.londoublegallatGalactic latitudedegpos.galactic.latdouble
bgdsBochum Galactic Disk Survey BGDS The Bochum Galactic Disk Survey is an ongoing project to monitor the +http://dc.g-vo.org/auger/q/cone/form .28493eventidAuger event numbermeta.id;meta.maincharraj2000Incoming cosmic ray direction, RAdegpos.eq.ra;meta.mainfloatdej2000Incoming cosmic ray direction, Declinationdegpos.eq.dec;meta.mainfloatnstatNumber of stations participating in an eventmeta.number;obsshortcreReconstructed energy of the cosmic ray particleEeVphys.energyfloatmjdObservation time, Modified Julian Daytime.epoch;obsfloatgallonGalactic longitudedegpos.galactic.londoublegallatGalactic latitudedegpos.galactic.latdoublebgdsBGDS time series +From the Bochum Galactic Disk Survey, time series have been obtained in the +r and i bands on an (up to) nightly basis. Depending on the field, the time +series contain up to more than 300 nights over more than 7 years. Each +measurement represents the averaged flux over 10 minutes of observation +(from 9 averaged 10s images). + +The Bochum Galactic Disk Survey is an ongoing project to monitor the +stellar content of the Galactic disk in a 6 degree wide stripe centered on +the Galactic plane. The data has been recorded since mid-2010 in Sloan r +and i simultaneously with the Robotic Bochum Twin Telescope (RoBoTT) at the +Universitaetssternwarte Bochum near Cerro Armazones in the Chilean Atacama +desert. It contains measurements of about 2x10^7 stars over more than seven +years. Additionally, intermittent measurements in Johnson UVB and Sloan z +have been recorded as well.bgds.data The Bochum Galactic Disk Survey is an ongoing project to monitor the stellar content of the Galactic disk in a 6 degree wide stripe centered on the Galactic plane. The data has been recorded since mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean Atacama desert. It contains measurements of about 2x10^7 stars over more than seven years. Additionally, intermittent measurements in -Johnson UVB and Sloan z have been recorded as well.
bgds.phot_all All mean photometry of bgds in one table. It may be simpler to write +Johnson UVB and Sloan z have been recorded as well.64413accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldSurvey field observed.meta.id;obs.fieldcharindexednullableexposureEffective exposure time (sum of exposure times of all images contributing here).stime.duration;obs.exposurefloatnullableairmassAirmass at mean epochobs.airMassfloatnullablemoondistMoon distance at mean epochdegobs.paramfloatnullablepub_didDataset identifier assigned by the publishermeta.id;meta.maincharnullable
bgds.phot_all All mean photometry of bgds in one table. It may be simpler to write queries against the split-band tables phot_band. Measurements in different fields and bands have not been merged, as that procedure is too error-prone in crowded milky way regions.band_nameThe band the mean photometry is given for.meta.id;instr.filtercharnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullableerr_magError in mean magnitude in this bandmagstat.error;phot.magfloatnullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablefluxMean flux in this band; this is computed from the mean magnitude based on Landolt standard stars.mJyphot.flux;stat.meanfloatnullableerr_fluxError in mean flux in this bandmJystat.error;phot.fluxfloatnullablenobsNumber of observations in this light curvemeta.number;obsshort
bgds.ssa_time_series This table contains about metadata about the photometric time series from BGDS in IVOA SSA format. The actual data is available through a -datalink service or in the phot_i and phot_r tables.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullabletime_minFirst timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.mindoublenullabletime_maxLast timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.maxdoublenullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullablefieldSurvey field observed.meta.id;obs.fieldcharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemjdsAn array containing the epochs of the time seriesdtime.epochdoublenullablemagsAn array containing the values of the time series.magphot.magfloatnullable
bgds.data The Bochum Galactic Disk Survey is an ongoing project to monitor the -stellar content of the Galactic disk in a 6 degree wide stripe -centered on the Galactic plane. The data has been recorded since -mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at -the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean -Atacama desert. It contains measurements of about 2x10^7 stars over -more than seven years. Additionally, intermittent measurements in -Johnson UVB and Sloan z have been recorded as well.64413accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldSurvey field observed.meta.id;obs.fieldcharindexednullableexposureEffective exposure time (sum of exposure times of all images contributing here).stime.duration;obs.exposurefloatnullableairmassAirmass at mean epochobs.airMassfloatnullablemoondistMoon distance at mean epochdegobs.paramfloatnullablepub_didDataset identifier assigned by the publishermeta.id;meta.maincharnullable
boydendeBoyden Station ADH Plates in GermanyThe Armagh-Dunsink-Harvard Becker-Schmidt Telescope was deployed at +datalink service or in the phot_i and phot_r tables.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullabletime_minFirst timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.mindoublenullabletime_maxLast timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.maxdoublenullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullablefieldSurvey field observed.meta.id;obs.fieldcharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemjdsAn array containing the epochs of the time seriesdtime.epochdoublenullablemagsAn array containing the values of the time series.magphot.magfloatnullableboydendeBoyden Station ADH Plates in GermanyThe Armagh-Dunsink-Harvard Becker-Schmidt Telescope was deployed at Boyden Station, Maselspoort South Africa between 1965 and 1970. During that time, astronomers from Bamberg, Heidelberg, Hamburg and Münster took astronomical images there, with a focus on old star clusters, the @@ -147,34 +154,34 @@ galaxies). A final product ("COMBO") combining both data sets, covering 3700-7500 Å at 6 Å bin size, is made availble for 484 galaxies. CALIFA is a legacy survey, intended for the community. This is the (final) -Data Release 3.califadr3.spectra Metadata for individual spectra. Note that the spectra result from -reducing a complex dithering scheme and are not independent from one -another.5100000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio at 500 nm (V500 spectra) or 400 nm (V1200 spectra)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoubleindexednullablecalifaidCALIFA id number of the target.meta.idshortindexedprimaryxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedprimaryyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedprimary
califadr3.fluxv500Flux and errors versus position for CALIFA setup v500. Positions are -pixel indices into the CALIFA cubes. The associate positions are in -califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, -yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.fluxv1200Flux and errors versus position for CALIFA setup v1200. Positions are -pixel indices into the CALIFA cubes. The associate positions are in -califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, -yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.fluxposv500 Data cubes of positions and fluxes in the optical for a sample of -galaxies, obtained by the CALIFA project in the v500 setup. +Data Release 3.
califadr3.cubes Metadata for the CALIFA data cubes as delivered by the project.1574accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullables_raRight ascension of galaxy center, J2000, from NEDdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDeclination of galaxy center, J2000, from NEDdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullableobs_ext_meanMean atmospheric extinction in V band over all pointings.magobs.atmos.extinction;em.opt.V;stat.meanfloatnullableobs_ext_maxMaximal atmospheric extinction in V band band among all pointings.magobs.atmos.extinction;em.opt.V;stat.maxfloatnullableobs_ext_rmsRMS atmospheric extinction in V band band over all pointingsmagstat.error;obs.atmos.extinction;em.opt.Vfloatnullableflag_obs_extQuality flag for atmospheric extinction in V band (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.atmos.extinction;em.opt.Vshortnullableobs_am_meanMean airmass (secz) over all pointings.magobs.airMass;stat.meanfloatnullableobs_am_maxMaximal airmass (secz) band among all pointings.magobs.airMass;stat.maxfloatnullableobs_am_rmsRMS airmass (secz) band over all pointingsmagstat.error;obs.airMassfloatnullableflag_obs_amQuality flag for airmass (secz) (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.airMassshortnullablered_disp_meanMean spectral dispersion FWHM over all pointings.Angstrominstr.dispersion;stat.meanfloatnullablered_disp_maxMaximal spectral dispersion FWHM band among all pointings.Angstrominstr.dispersion;stat.maxfloatnullablered_disp_rmsRMS spectral dispersion FWHM band over all pointingsAngstromstat.error;instr.dispersionfloatnullableflag_red_dispQuality flag for spectral dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_cdisp_meanMean cross-dispersion FWHM over all pointings.pixinstr.dispersion;stat.meanfloatnullablered_cdisp_maxMaximal cross-dispersion FWHM band among all pointings.pixinstr.dispersion;stat.maxfloatnullablered_cdisp_rmsRMS cross-dispersion FWHM band over all pointingspixstat.error;instr.dispersionfloatnullableflag_red_cdispQuality flag for cross-dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_resskyline_minFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), minimum over all pointingscountstat.fit.residual;spect.line;stat.minfloatnullablered_resskyline_maxFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullablered_rmsresskyline_maxRMS flux residual over all fibers of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullableflag_red_skylinesFlag denoting problems with the sky substractionmeta.code.qualshortnullablered_meanstraylight_maxMaximum of mean straylight intensity over all pointingscountinstr.background;stat.meanfloatnullablered_maxstraylight_maxMaximum of maximum straylight intensity over all pointingscountinstr.background;stat.maxfloatnullablered_rmsstraylight_maxMaximum of RMS straylight intensity over all pointingscountinstr.backgroundfloatnullableflag_red_straylightFlag for critical straylight.meta.code.qualshortnullableobs_skymag_meanMean V band sky surface brightness over all pointings.mag/arcsec**2phot.mag.sb;instr.skyLevel;em.opt.V;stat.meanfloatnullableobs_skymag_rmsRMS of V band sky surface brightness over all pointings.mag/arcsec**2stat.error;phot.mag.sb;instr.skyLevel;em.opt.Vfloatnullableflag_obs_skymagFlag for critical sky surface brightness.meta.code.qualshortnullablered_limsb3-sigma limiting surface brightness in B band in mag.mag/arcsec**2phot.mag.sb;em.opt.B;stat.minfloatnullablered_limsbflux3-sigma limiting surface brightness in B band as flux.erg.cm**-2.s**-1.Angstrom**-1.arcsec**-2floatnullableflag_red_limsbFlag for critical limiting surface brightness sensitivity.meta.code.qualshortnullablered_frac_bigerrFraction of bad pixels (error larger than five times the value) in this cube.instr.det.noise;arith.ratiofloatnullableflag_red_errspecFlag indicating excessive bad pixels.meta.code.qualshortnullablecal_qflux_gAverage flux ratio relative to SDSS g mean over all pointingsphot.flux;em.opt.V;arith.ratiofloatnullablecal_qflux_rAverage flux ratio relative to SDSS r mean over all pointingsphot.flux;em.opt.R;arith.ratiofloatnullablecal_qflux_rmsAverage flux ratio relative to SDSS g and r RMS over all pointingsstat.error;em.opt;arith.ratiofloatnullableflag_cal_specphotoFlag for problems with spectro-photometric calibration.meta.code.qualshortnullablecal_rmsvelmeanRMS of radial velocity residuals of estimates based on 3 or 4 spectral subranges wrt the estimates from the full spectrum.km/sstat.error;instr.calibfloatnullableflag_cal_wlFlag for critical wavelength calibration stability.meta.code.qualshortnullableflag_cal_imgqualFlag for visually evident problems in this cubemeta.code.qualshortnullableflag_cal_specqualFlag for visually evident problems in a 30''-aperture spectrum generated from this cubemeta.code.qualshortnullablecal_flatsdssFlag for visually evident problems in the `SDSS flat' (see source paper); NULL here means: no SDSS flat applied.meta.code.qualshortnullableflag_cal_registrationFlag for visually evident problems in the registration of the synthetic broad-band image with SDSS and related procedures.meta.code.qualshortnullableflag_cal_v1200v500Set if a visual check for the 30''-aperture integrated spectra in V500, V1200, and COMB showed problems.meta.code.qualshortnullableobs_seeing_meanMean FWHM seeing over all pointingsarcsecinstr.obsty.seeing;stat.meanfloatnullableobs_seeing_rmsRMS of FWHM seeing over all pointingsarcsecstat.error;instr.obsty.seeingfloatnullablecal_snr1hlrSignal to noise ratio at the half-light ratio.stat.snrfloatnullablenotesNotesmeta.notecharnullablesetupInstrument setup (V500, V1200, or COMBO)meta.code;instrcharnullable
califadr3.fluxposv1200 Data cubes of positions and fluxes in the optical for a sample of +galaxies, obtained by the CALIFA project in the v1200 setup. Note that due to the dithering scheme, the points here do not actually correspond to raw measurements but instead represent a reduction of -several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.fluxposv1200 Data cubes of positions and fluxes in the optical for a sample of -galaxies, obtained by the CALIFA project in the v1200 setup. +several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.fluxposv500 Data cubes of positions and fluxes in the optical for a sample of +galaxies, obtained by the CALIFA project in the v500 setup. Note that due to the dithering scheme, the points here do not actually correspond to raw measurements but instead represent a reduction of -several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.cubes Metadata for the CALIFA data cubes as delivered by the project.1574accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullables_raRight ascension of galaxy center, J2000, from NEDdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDeclination of galaxy center, J2000, from NEDdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullableobs_ext_meanMean atmospheric extinction in V band over all pointings.magobs.atmos.extinction;em.opt.V;stat.meanfloatnullableobs_ext_maxMaximal atmospheric extinction in V band band among all pointings.magobs.atmos.extinction;em.opt.V;stat.maxfloatnullableobs_ext_rmsRMS atmospheric extinction in V band band over all pointingsmagstat.error;obs.atmos.extinction;em.opt.Vfloatnullableflag_obs_extQuality flag for atmospheric extinction in V band (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.atmos.extinction;em.opt.Vshortnullableobs_am_meanMean airmass (secz) over all pointings.magobs.airMass;stat.meanfloatnullableobs_am_maxMaximal airmass (secz) band among all pointings.magobs.airMass;stat.maxfloatnullableobs_am_rmsRMS airmass (secz) band over all pointingsmagstat.error;obs.airMassfloatnullableflag_obs_amQuality flag for airmass (secz) (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.airMassshortnullablered_disp_meanMean spectral dispersion FWHM over all pointings.Angstrominstr.dispersion;stat.meanfloatnullablered_disp_maxMaximal spectral dispersion FWHM band among all pointings.Angstrominstr.dispersion;stat.maxfloatnullablered_disp_rmsRMS spectral dispersion FWHM band over all pointingsAngstromstat.error;instr.dispersionfloatnullableflag_red_dispQuality flag for spectral dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_cdisp_meanMean cross-dispersion FWHM over all pointings.pixinstr.dispersion;stat.meanfloatnullablered_cdisp_maxMaximal cross-dispersion FWHM band among all pointings.pixinstr.dispersion;stat.maxfloatnullablered_cdisp_rmsRMS cross-dispersion FWHM band over all pointingspixstat.error;instr.dispersionfloatnullableflag_red_cdispQuality flag for cross-dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_resskyline_minFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), minimum over all pointingscountstat.fit.residual;spect.line;stat.minfloatnullablered_resskyline_maxFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullablered_rmsresskyline_maxRMS flux residual over all fibers of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullableflag_red_skylinesFlag denoting problems with the sky substractionmeta.code.qualshortnullablered_meanstraylight_maxMaximum of mean straylight intensity over all pointingscountinstr.background;stat.meanfloatnullablered_maxstraylight_maxMaximum of maximum straylight intensity over all pointingscountinstr.background;stat.maxfloatnullablered_rmsstraylight_maxMaximum of RMS straylight intensity over all pointingscountinstr.backgroundfloatnullableflag_red_straylightFlag for critical straylight.meta.code.qualshortnullableobs_skymag_meanMean V band sky surface brightness over all pointings.mag/arcsec**2phot.mag.sb;instr.skyLevel;em.opt.V;stat.meanfloatnullableobs_skymag_rmsRMS of V band sky surface brightness over all pointings.mag/arcsec**2stat.error;phot.mag.sb;instr.skyLevel;em.opt.Vfloatnullableflag_obs_skymagFlag for critical sky surface brightness.meta.code.qualshortnullablered_limsb3-sigma limiting surface brightness in B band in mag.mag/arcsec**2phot.mag.sb;em.opt.B;stat.minfloatnullablered_limsbflux3-sigma limiting surface brightness in B band as flux.erg.cm**-2.s**-1.Angstrom**-1.arcsec**-2floatnullableflag_red_limsbFlag for critical limiting surface brightness sensitivity.meta.code.qualshortnullablered_frac_bigerrFraction of bad pixels (error larger than five times the value) in this cube.instr.det.noise;arith.ratiofloatnullableflag_red_errspecFlag indicating excessive bad pixels.meta.code.qualshortnullablecal_qflux_gAverage flux ratio relative to SDSS g mean over all pointingsphot.flux;em.opt.V;arith.ratiofloatnullablecal_qflux_rAverage flux ratio relative to SDSS r mean over all pointingsphot.flux;em.opt.R;arith.ratiofloatnullablecal_qflux_rmsAverage flux ratio relative to SDSS g and r RMS over all pointingsstat.error;em.opt;arith.ratiofloatnullableflag_cal_specphotoFlag for problems with spectro-photometric calibration.meta.code.qualshortnullablecal_rmsvelmeanRMS of radial velocity residuals of estimates based on 3 or 4 spectral subranges wrt the estimates from the full spectrum.km/sstat.error;instr.calibfloatnullableflag_cal_wlFlag for critical wavelength calibration stability.meta.code.qualshortnullableflag_cal_imgqualFlag for visually evident problems in this cubemeta.code.qualshortnullableflag_cal_specqualFlag for visually evident problems in a 30''-aperture spectrum generated from this cubemeta.code.qualshortnullablecal_flatsdssFlag for visually evident problems in the `SDSS flat' (see source paper); NULL here means: no SDSS flat applied.meta.code.qualshortnullableflag_cal_registrationFlag for visually evident problems in the registration of the synthetic broad-band image with SDSS and related procedures.meta.code.qualshortnullableflag_cal_v1200v500Set if a visual check for the 30''-aperture integrated spectra in V500, V1200, and COMB showed problems.meta.code.qualshortnullableobs_seeing_meanMean FWHM seeing over all pointingsarcsecinstr.obsty.seeing;stat.meanfloatnullableobs_seeing_rmsRMS of FWHM seeing over all pointingsarcsecstat.error;instr.obsty.seeingfloatnullablecal_snr1hlrSignal to noise ratio at the half-light ratio.stat.snrfloatnullablenotesNotesmeta.notecharnullablesetupInstrument setup (V500, V1200, or COMBO)meta.code;instrcharnullable
califadr3.objects Object data for DR3 sample. +several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.fluxv1200Flux and errors versus position for CALIFA setup v1200. Positions are +pixel indices into the CALIFA cubes. The associate positions are in +califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, +yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.fluxv500Flux and errors versus position for CALIFA setup v500. Positions are +pixel indices into the CALIFA cubes. The associate positions are in +califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, +yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.objects Object data for DR3 sample. The photometric and derived quantities are from growth curve analysis of the SDSS images for galaxies from the mother sample -(califaid<1000), from SDSS DR7/12 photometry otherwise.667target_nameObject a targeted observation targetedmeta.id;srcobscore:Target.NamecharnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortraj2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.ra;meta.maindoublenullabledej2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.dec;meta.maindoublenullableredshiftRedshift, from growth curve analysis photometry for mother sample galaxies, from SDSS DR7/12 petrosian photometry otherwise.src.redshiftfloatnullablesdss_zRedshift taken from SDSS DR7src.redshiftfloatnullablemaj_axisApparent isophotal major axis from SDSSarcsecphys.angSize;srcfloatnullablemstarStellar masslog(solMass)phys.massfloatnullablemstar_min3 sigma lower limit of Stellar masslog(solMass)phys.mass;stat.minfloatnullablemstar_max3 sigma upper limit of Stellar masslog(solMass)phys.mass;stat.maxfloatnullablechi2χ² of best fitstat.fit.chi2floatnullablevmax_nocorrSurvey volume for this galaxy from apparent isophotal diameter and measured redshift (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablevmax_denscorrV_max additionally corrected for cosmic variance (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablemaguMagnitude in the u band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ufloatnullableerr_maguError in m_ustat.error;phot.mag;em.opt.Ufloatnullableu_extExtinction in the u bandphys.absorption;em.opt.Ufloatnullableabs_u_min3 sigma lower limit of the absolute magnitude in uphot.mag;em.opt.U;stat.minfloatnullableabs_u_max3 sigma upper limit of the absolute magnitude in uphot.mag;em.opt.U;stat.maxfloatnullablemaggMagnitude in the g band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Vfloatnullableerr_maggError in m_gstat.error;phot.mag;em.opt.Vfloatnullableg_extExtinction in the g bandphys.absorption;em.opt.Vfloatnullableabs_g_min3 sigma lower limit of the absolute magnitude in gphot.mag;em.opt.V;stat.minfloatnullableabs_g_max3 sigma upper limit of the absolute magnitude in gphot.mag;em.opt.V;stat.maxfloatnullablemagrMagnitude in the r band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Rfloatnullableerr_magrError in m_rstat.error;phot.mag;em.opt.Rfloatnullabler_extExtinction in the r bandphys.absorption;em.opt.Rfloatnullableabs_r_min3 sigma lower limit of the absolute magnitude in rphot.mag;em.opt.R;stat.minfloatnullableabs_r_max3 sigma upper limit of the absolute magnitude in rphot.mag;em.opt.R;stat.maxfloatnullablemagiMagnitude in the i band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magiError in m_istat.error;phot.mag;em.opt.Ifloatnullablei_extExtinction in the i bandphys.absorption;em.opt.Ifloatnullableabs_i_min3 sigma lower limit of the absolute magnitude in iphot.mag;em.opt.I;stat.minfloatnullableabs_i_max3 sigma upper limit of the absolute magnitude in iphot.mag;em.opt.I;stat.maxfloatnullablemagzMagnitude in the z band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magzError in m_zstat.error;phot.mag;em.opt.Ifloatnullablez_extExtinction in the z bandphys.absorption;em.opt.Ifloatnullableabs_z_min3 sigma lower limit of the absolute magnitude in zphot.mag;em.opt.I;stat.minfloatnullableabs_z_max3 sigma upper limit of the absolute magnitude in zphot.mag;em.opt.I;stat.maxfloatnullablehubtypMorphological type from CALIFA's own visual classification (see 2014A&A...569A...1W for details). (M) indicates definite merging going on, (m) indicates likely merging, (i) indicates signs of interaction.src.morph.typecharminhubtypEarliest morphological type in CALIFA's estimationsrc.morph.typecharmaxhubtypLatest morphological type in CALIFA's estimationsrc.morph.typecharbarBar strength, A -- strong bar, AB -- intermediate, B -- weak bar; with minimum and maximum estimates.meta.code;src.morphcharnullableflag_release_combCube in setup COMB available?meta.code;meta.datasetshortflag_release_v1200Cube in setup V1200 available?meta.code;meta.datasetshortflag_release_v500Cube in setup V500 available?meta.code;meta.datasetshortaxis_ratiob/a axis ratio of a moment-based anaylsis of the SDSS DR7 images (cf. 2014A&A...569A...1W).phys.angSize;arith.ratiofloatnullableposition_anglePosition angle wrt north.degpos.posAngfloatnullableel_hlrPetrosian half-light radius in r bandarcsecphys.angSize;srcfloatnullablemodmag_rModel magnitude in r bandmagphot.mag;meta.modelledfloatnullablecalifadr3.cubescalifaidcalifaid
carsCARS survey dataImages and data from from the CFHTLS archive research survey, a +(califaid<1000), from SDSS DR7/12 photometry otherwise.667target_nameObject a targeted observation targetedmeta.id;srcobscore:Target.NamecharnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortraj2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.ra;meta.maindoublenullabledej2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.dec;meta.maindoublenullableredshiftRedshift, from growth curve analysis photometry for mother sample galaxies, from SDSS DR7/12 petrosian photometry otherwise.src.redshiftfloatnullablesdss_zRedshift taken from SDSS DR7src.redshiftfloatnullablemaj_axisApparent isophotal major axis from SDSSarcsecphys.angSize;srcfloatnullablemstarStellar masslog(solMass)phys.massfloatnullablemstar_min3 sigma lower limit of Stellar masslog(solMass)phys.mass;stat.minfloatnullablemstar_max3 sigma upper limit of Stellar masslog(solMass)phys.mass;stat.maxfloatnullablechi2χ² of best fitstat.fit.chi2floatnullablevmax_nocorrSurvey volume for this galaxy from apparent isophotal diameter and measured redshift (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablevmax_denscorrV_max additionally corrected for cosmic variance (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablemaguMagnitude in the u band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ufloatnullableerr_maguError in m_ustat.error;phot.mag;em.opt.Ufloatnullableu_extExtinction in the u bandphys.absorption;em.opt.Ufloatnullableabs_u_min3 sigma lower limit of the absolute magnitude in uphot.mag;em.opt.U;stat.minfloatnullableabs_u_max3 sigma upper limit of the absolute magnitude in uphot.mag;em.opt.U;stat.maxfloatnullablemaggMagnitude in the g band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Vfloatnullableerr_maggError in m_gstat.error;phot.mag;em.opt.Vfloatnullableg_extExtinction in the g bandphys.absorption;em.opt.Vfloatnullableabs_g_min3 sigma lower limit of the absolute magnitude in gphot.mag;em.opt.V;stat.minfloatnullableabs_g_max3 sigma upper limit of the absolute magnitude in gphot.mag;em.opt.V;stat.maxfloatnullablemagrMagnitude in the r band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Rfloatnullableerr_magrError in m_rstat.error;phot.mag;em.opt.Rfloatnullabler_extExtinction in the r bandphys.absorption;em.opt.Rfloatnullableabs_r_min3 sigma lower limit of the absolute magnitude in rphot.mag;em.opt.R;stat.minfloatnullableabs_r_max3 sigma upper limit of the absolute magnitude in rphot.mag;em.opt.R;stat.maxfloatnullablemagiMagnitude in the i band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magiError in m_istat.error;phot.mag;em.opt.Ifloatnullablei_extExtinction in the i bandphys.absorption;em.opt.Ifloatnullableabs_i_min3 sigma lower limit of the absolute magnitude in iphot.mag;em.opt.I;stat.minfloatnullableabs_i_max3 sigma upper limit of the absolute magnitude in iphot.mag;em.opt.I;stat.maxfloatnullablemagzMagnitude in the z band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magzError in m_zstat.error;phot.mag;em.opt.Ifloatnullablez_extExtinction in the z bandphys.absorption;em.opt.Ifloatnullableabs_z_min3 sigma lower limit of the absolute magnitude in zphot.mag;em.opt.I;stat.minfloatnullableabs_z_max3 sigma upper limit of the absolute magnitude in zphot.mag;em.opt.I;stat.maxfloatnullablehubtypMorphological type from CALIFA's own visual classification (see 2014A&A...569A...1W for details). (M) indicates definite merging going on, (m) indicates likely merging, (i) indicates signs of interaction.src.morph.typecharminhubtypEarliest morphological type in CALIFA's estimationsrc.morph.typecharmaxhubtypLatest morphological type in CALIFA's estimationsrc.morph.typecharbarBar strength, A -- strong bar, AB -- intermediate, B -- weak bar; with minimum and maximum estimates.meta.code;src.morphcharnullableflag_release_combCube in setup COMB available?meta.code;meta.datasetshortflag_release_v1200Cube in setup V1200 available?meta.code;meta.datasetshortflag_release_v500Cube in setup V500 available?meta.code;meta.datasetshortaxis_ratiob/a axis ratio of a moment-based anaylsis of the SDSS DR7 images (cf. 2014A&A...569A...1W).phys.angSize;arith.ratiofloatnullableposition_anglePosition angle wrt north.degpos.posAngfloatnullableel_hlrPetrosian half-light radius in r bandarcsecphys.angSize;srcfloatnullablemodmag_rModel magnitude in r bandmagphot.mag;meta.modelledfloatnullablecalifadr3.cubescalifaidcalifaidcalifadr3.spectra Metadata for individual spectra. Note that the spectra result from +reducing a complex dithering scheme and are not independent from one +another.5100000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio at 500 nm (V500 spectra) or 400 nm (V1200 spectra)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoubleindexednullablecalifaidCALIFA id number of the target.meta.idshortindexedprimaryxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedprimaryyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedprimary
carsCARS survey dataImages and data from from the CFHTLS archive research survey, a multi-band dataset spanning 37 square degrees of sky in high galactic -latitudes.cars.srccatExtracted sources from the CARS survey, comprising positions and -multiband photometry.5200000carsidCARS object IDmeta.id;meta.maincharindexedprimaryseqnrRunning object number (in field)meta.idintraj2000Right ascension of barycenter (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of barycenter (J2000)degpos.eq.dec;meta.maindoubleindexednullablexposObject position on exposure along xpixpos.cartesian.x;instr.detfloatnullableyposObject position on exposure along ypixpos.cartesian.y;instr.detfloatnullablemagautoKron-like elliptical aperture magnitudemagphot.magfloatindexednullablemagerrautoError in Kron-like elliptical aperture magnitudemagstat.error;phot.magfloatnullablemagisouIsophotal magnitude in the u* bandmagphot.mag;em.optfloatnullablemagisoerruRMS error of isophotal magnitude in the u* bandmagstat.error;phot.mag;em.optfloatnullablemagapruFixed aperture magnitude in the u* bandmagphot.mag;em.optfloatnullablemagaprerruRMS error of fixed aperture magnitude in the u* bandmagstat.error;phot.mag;em.optfloatnullablemaglimuLimiting magnitude at object's position in u* bandmagfloatnullablemagisogIsophotal magnitude in the g' bandmagphot.mag;em.optfloatnullablemagisoerrgRMS error of isophotal magnitude in the g' bandmagstat.error;phot.mag;em.optfloatnullablemagaprgFixed aperture magnitude in the g' bandmagphot.mag;em.optfloatnullablemagaprerrgRMS error of fixed aperture magnitude in the g' bandmagstat.error;phot.mag;em.optfloatnullablemaglimgLimiting magnitude at object's position in g' bandmagfloatnullablemagisorIsophotal magnitude in the r' bandmagphot.mag;em.optfloatnullablemagisoerrrRMS error of isophotal magnitude in the r' bandmagstat.error;phot.mag;em.optfloatnullablemagaprrFixed aperture magnitude in the r' bandmagphot.mag;em.optfloatnullablemagaprerrrRMS error of fixed aperture magnitude in the r' bandmagstat.error;phot.mag;em.optfloatnullablemaglimrLimiting magnitude at object's position in r' bandmagfloatnullablemagisoiIsophotal magnitude in the i' bandmagphot.mag;em.optfloatnullablemagisoerriRMS error of isophotal magnitude in the i' bandmagstat.error;phot.mag;em.optfloatnullablemagapriFixed aperture magnitude in the i' bandmagphot.mag;em.optfloatnullablemagaprerriRMS error of fixed aperture magnitude in the i' bandmagstat.error;phot.mag;em.optfloatnullablemaglimiLimiting magnitude at object's position in i' bandmagfloatnullablemagisozIsophotal magnitude in the z' bandmagphot.mag;em.optfloatnullablemagisoerrzRMS error of isophotal magnitude in the z' bandmagstat.error;phot.mag;em.optfloatnullablemagaprzFixed aperture magnitude in the z' bandmagphot.mag;em.optfloatnullablemagaprerrzRMS error of fixed aperture magnitude in the z' bandmagstat.error;phot.mag;em.optfloatnullablemaglimzLimiting magnitude at object's position in z' bandmagfloatnullablefwhmFull width half max assuming a gaussian coredegphys.angSizefloatindexednullablefluxradiusFraction-of-light radiuspixfloatnullablemajoraxisProfile RMS along major axisdegphys.angSize.smajAxisfloatnullableminoraxisProfile RMS along minor axisdegphys.angSize.sminAxisfloatnullablethetaPosition angle (east of north) (J2000)degpos.posAngfloatnullablesgclassS/G classifier output (0..1)src.class.starGalaxyfloatnullableextflagsExtraction FlagsintmaskTrue if object is within an object maskmeta.codebooleanz_bPhotometric redshiftfloatnullablet_bMask valuefloatnullableoddsConfidence parameter for photometric redshiftfloatnullablengoodfiltersNumber of filters with good photometry for BPZmeta.code.qualintnbadfiltersNumber of filters with bad photometry for BPZmeta.code.qualintnfaintfiltersNumber of filters with faint photometry for BPZmeta.code.qualintgoodfiltersFilters with faint photometry for BPZcharnullablebadfiltersFilters with bad photometry for BPZcharnullablefaintfiltersFilters with faint photometry for BPZcharnullablefieldkeyCARS field designationmeta.idcharnullable
cars.images +latitudes.
cars.images Metadata for co-added CFHTLS archive images -used for producing the CARS source list (cars.srccat).185accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldkeyCARS field designationmeta.idcharnullablefieldbandkeyCARS field designation plus bandmeta.idcharnullablencombineNumber of individual frames in this stackmeta.numberinttexptimeTotal Exposure Timestime.duration;obs.exposurefloatnullablemagzpAB Magnitude Zeropointmagphot.mag;arith.zpfloatnullablemagzperrEstimated Magnitude Zeropoint Errormagstat.error;phot.mag;arith.zpfloatnullableseeingMeasured image seeingarcsecinstr.obsty.seeingfloatnullableseeingerrMeasured image Seeing errorarcsecstat.error;instr.obsty.seeingfloatnullable
carsarcsGravitational arc candidates in the CFHTLS-Archive-Research Survey +used for producing the CARS source list (cars.srccat).</description><nrows>185</nrows><column><name>accref</name><description>Access key for the data</description><ucd>meta.ref.url</ucd><utype>Access.Reference</utype><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>indexed</flag><flag>nullable</flag></column><column><name>owner</name><description>Owner of the data</description><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>embargo</name><description>Date the data will become/became public</description><unit>a</unit><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>mime</name><description>MIME type of the file served</description><ucd>meta.code.mime</ucd><utype>Access.Format</utype><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="1.76401e+09" g-colstat:median="1.76401e+09" g-colstat:min-value="1.76401e+09" g-colstat:percentile03="1.76401e+09" g-colstat:percentile97="1.76401e+09"><name>accsize</name><description>Size of the data in bytes</description><unit>byte</unit><ucd>VOX:Image_FileSize</ucd><utype>Access.Size</utype><dataType xsi:type="vs:VOTableType">long</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="335.224" g-colstat:median="38.3285" g-colstat:min-value="33.5429" g-colstat:percentile03="33.5429" g-colstat:percentile97="335.224"><name>centeralpha</name><description>Approximate center of image, RA</description><unit>deg</unit><ucd>pos.eq.ra</ucd><dataType xsi:type="vs:VOTableType">double</dataType><flag>indexed</flag><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="52.6419" g-colstat:median="-4.2" g-colstat:min-value="-7.93333" g-colstat:percentile03="-7" g-colstat:percentile97="52.6419"><name>centerdelta</name><description>Approximate center of image, Dec</description><unit>deg</unit><ucd>pos.eq.dec</ucd><dataType xsi:type="vs:VOTableType">double</dataType><flag>indexed</flag><flag>nullable</flag></column><column><name>imagetitle</name><description>Synthetic name of the image</description><ucd>meta.title</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>instid</name><description>Identifier of the originating instrument</description><ucd>meta.id;instr</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0"><name>dateobs</name><description>Epoch at midpoint of observation</description><unit>d</unit><ucd>time;obs.exposure</ucd><dataType xsi:type="vs:VOTableType">double</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="2" g-colstat:median="2" g-colstat:min-value="2" g-colstat:percentile03="2" g-colstat:percentile97="2"><name>naxes</name><description>Number of axes in data</description><ucd>pos.wcs.naxes</ucd><dataType xsi:type="vs:VOTableType">int</dataType><flag>nullable</flag></column><column><name>pixelsize</name><description>Number of pixels along each of the axes</description><unit>pixel</unit><ucd>pos.wcs.naxis</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">int</dataType><flag>nullable</flag></column><column><name>pixelscale</name><description>The pixel scale on each image axis</description><unit>deg/pixel</unit><ucd>pos.wcs.scale</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>refframe</name><description>Coordinate system reference frame</description><ucd>pos.frame</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="2000" g-colstat:median="2000" g-colstat:min-value="2000" g-colstat:percentile03="2000" g-colstat:percentile97="2000"><name>wcs_equinox</name><description>Equinox of the given coordinates</description><unit>yr</unit><ucd>time.equinox</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>wcs_projection</name><description>FITS WCS projection type</description><ucd>pos.wcs.ctype</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>wcs_refpixel</name><description>WCS reference pixel</description><unit>pixel</unit><ucd>pos.wcs.crpix</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>wcs_refvalues</name><description>World coordinates at WCS reference pixel</description><unit>deg</unit><ucd>pos.wcs.crval</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">double</dataType><flag>nullable</flag></column><column><name>wcs_cdmatrix</name><description>FITS WCS CDij matrix</description><unit>deg/pixel</unit><ucd>pos.wcs.cdmatrix</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>bandpassid</name><description>Freeform name of the bandpass used</description><ucd>instr.bandpass</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>bandpassunit</name><description>Unit of bandpass specifications (always m).</description><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="1.17e-06" g-colstat:median="6.28e-07" g-colstat:min-value="3.74e-07" g-colstat:percentile03="3.74e-07" g-colstat:percentile97="1.17e-06"><name>bandpassrefval</name><description>Characteristic quantity for the bandpass of the image</description><unit>m</unit><ucd>instr.bandpass;stat.median</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="1.2e-06" g-colstat:median="6.95e-07" g-colstat:min-value="4.2e-07" g-colstat:percentile03="4.2e-07" g-colstat:percentile97="1.2e-06"><name>bandpasshi</name><description>Upper limit of the bandpass (in BandPass_Unit units)</description><unit>m</unit><ucd>instr.bandpass;stat.max</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="8.1e-07" g-colstat:median="5.5e-07" g-colstat:min-value="3.3e-07" g-colstat:percentile03="3.3e-07" g-colstat:percentile97="8.1e-07"><name>bandpasslo</name><description>Lower limit of the bandpass (in BandPass_Unit units)</description><unit>m</unit><ucd>instr.bandpass;stat.min</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>pixflags</name><description>Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display only</description><ucd>meta.code</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>coverage</name><description>Field covered by the image</description><unit>deg</unit><dataType arraysize="*" extendedType="polygon" xsi:type="vs:VOTableType">double</dataType><flag>indexed</flag><flag>nullable</flag></column><column><name>fieldkey</name><description>CARS field designation</description><ucd>meta.id</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>fieldbandkey</name><description>CARS field designation plus band</description><ucd>meta.id</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="14" g-colstat:median="5" g-colstat:min-value="2" g-colstat:percentile03="2" g-colstat:percentile97="12"><name>ncombine</name><description>Number of individual frames in this stack</description><ucd>meta.number</ucd><dataType xsi:type="vs:VOTableType">int</dataType></column><column g-colstat:fillFactor="1" g-colstat:max-value="8611.03" g-colstat:median="3000.53" g-colstat:min-value="1000.1" g-colstat:percentile03="1000.15" g-colstat:percentile97="7200.56"><name>texptime</name><description>Total Exposure Time</description><unit>s</unit><ucd>time.duration;obs.exposure</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="26.5" g-colstat:median="25.73" g-colstat:min-value="24.67" g-colstat:percentile03="24.71" g-colstat:percentile97="26.4603"><name>magzp</name><description>AB Magnitude Zeropoint</description><unit>mag</unit><ucd>phot.mag;arith.zp</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="0.15" g-colstat:median="0.05" g-colstat:min-value="0.05" g-colstat:percentile03="0.05" g-colstat:percentile97="0.15"><name>magzperr</name><description>Estimated Magnitude Zeropoint Error</description><unit>mag</unit><ucd>stat.error;phot.mag;arith.zp</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="1.11" g-colstat:median="0.79" g-colstat:min-value="0.48" g-colstat:percentile03="0.53" g-colstat:percentile97="1"><name>seeing</name><description>Measured image seeing</description><unit>arcsec</unit><ucd>instr.obsty.seeing</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="0.13" g-colstat:median="0.01" g-colstat:min-value="0" g-colstat:percentile03="0" g-colstat:percentile97="0.0748"><name>seeingerr</name><description>Measured image Seeing error</description><unit>arcsec</unit><ucd>stat.error;instr.obsty.seeing</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column></table><table><name>cars.srccat</name><description>Extracted sources from the CARS survey, comprising positions and +multiband photometry.</description><nrows>5200000</nrows><column><name>carsid</name><description>CARS object ID</description><ucd>meta.id;meta.main</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>indexed</flag><flag>primary</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="197808" g-colstat:median="69959" g-colstat:min-value="1" g-colstat:percentile03="4174" g-colstat:percentile97="159735"><name>seqnr</name><description>Running object number (in field)</description><ucd>meta.id</ucd><dataType xsi:type="vs:VOTableType">int</dataType></column><column g-colstat:fillFactor="1" g-colstat:max-value="335.719" g-colstat:median="38.5181" g-colstat:min-value="33.0391" g-colstat:percentile03="33.4023" g-colstat:percentile97="335.428"><name>raj2000</name><description>Right ascension of barycenter (J2000)</description><unit>deg</unit><ucd>pos.eq.ra;meta.main</ucd><dataType xsi:type="vs:VOTableType">double</dataType><flag>indexed</flag><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="53.1711" g-colstat:median="-3.85261" g-colstat:min-value="-8.45327" g-colstat:percentile03="-7.43634" g-colstat:percentile97="52.7762"><name>dej2000</name><description>Declination of barycenter (J2000)</description><unit>deg</unit><ucd>pos.eq.dec;meta.main</ucd><dataType xsi:type="vs:VOTableType">double</dataType><flag>indexed</flag><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="20246" g-colstat:median="10536.1" g-colstat:min-value="852.307" g-colstat:percentile03="1611.14" g-colstat:percentile97="19493.8"><name>xpos</name><description>Object position on exposure along x</description><unit>pix</unit><ucd>pos.cartesian.x;instr.det</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="20913" g-colstat:median="10692.9" g-colstat:min-value="315.733" g-colstat:percentile03="1312.74" g-colstat:percentile97="19858.7"><name>ypos</name><description>Object position on exposure along y</description><unit>pix</unit><ucd>pos.cartesian.y;instr.det</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.999771" g-colstat:max-value="33.1648" g-colstat:median="23.8094" g-colstat:min-value="10.5808" g-colstat:percentile03="19.6441" g-colstat:percentile97="25.348"><name>magauto</name><description>Kron-like elliptical aperture magnitude</description><unit>mag</unit><ucd>phot.mag</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>indexed</flag><flag>nullable</flag></column><column g-colstat:fillFactor="0.999771" g-colstat:max-value="316.178" g-colstat:median="0.080472" g-colstat:min-value="2.9648e-05" g-colstat:percentile03="0.00298989" g-colstat:percentile97="0.177188"><name>magerrauto</name><description>Error in Kron-like elliptical aperture magnitude</description><unit>mag</unit><ucd>stat.error;phot.mag</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.934003" g-colstat:max-value="35.6951" g-colstat:median="26.5314" g-colstat:min-value="14.443" g-colstat:percentile03="22.5473" g-colstat:percentile97="29.8237"><name>magisou</name><description>Isophotal magnitude in the u* band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.934003" g-colstat:max-value="99.9376" g-colstat:median="0.128335" g-colstat:min-value="9.83874e-05" g-colstat:percentile03="0.0114164" g-colstat:percentile97="1.86007"><name>magisoerru</name><description>RMS error of isophotal magnitude in the u* band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.933742" g-colstat:max-value="35.5619" g-colstat:median="25.528" g-colstat:min-value="16.1688" g-colstat:percentile03="22.8035" g-colstat:percentile97="28.2842"><name>magapru</name><description>Fixed aperture magnitude in the u* band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.933742" g-colstat:max-value="99.3855" g-colstat:median="0.113812" g-colstat:min-value="0.000248997" g-colstat:percentile03="0.0103183" g-colstat:percentile97="1.51807"><name>magaprerru</name><description>RMS error of fixed aperture magnitude in the u* band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.998128" g-colstat:max-value="106.58" g-colstat:median="28.047" g-colstat:min-value="22.6563" g-colstat:percentile03="27.457" g-colstat:percentile97="28.4962"><name>maglimu</name><description>Limiting magnitude at object's position in u* band</description><unit>mag</unit><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.979261" g-colstat:max-value="35.7018" g-colstat:median="25.8491" g-colstat:min-value="13.3111" g-colstat:percentile03="21.4617" g-colstat:percentile97="28.6705"><name>magisog</name><description>Isophotal magnitude in the g' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.979261" g-colstat:max-value="99.905" g-colstat:median="0.0460434" g-colstat:min-value="4.79987e-05" g-colstat:percentile03="0.00312328" g-colstat:percentile97="0.414294"><name>magisoerrg</name><description>RMS error of isophotal magnitude in the g' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.985983" g-colstat:max-value="36.2392" g-colstat:median="24.8844" g-colstat:min-value="16.4094" g-colstat:percentile03="21.6129" g-colstat:percentile97="26.9478"><name>magaprg</name><description>Fixed aperture magnitude in the g' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.985983" g-colstat:max-value="99.3522" g-colstat:median="0.0401344" g-colstat:min-value="0.000142581" g-colstat:percentile03="0.00276168" g-colstat:percentile97="0.34954"><name>magaprerrg</name><description>RMS error of fixed aperture magnitude in the g' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.998303" g-colstat:max-value="125.131" g-colstat:median="28.3204" g-colstat:min-value="21.4209" g-colstat:percentile03="27.8096" g-colstat:percentile97="28.783"><name>maglimg</name><description>Limiting magnitude at object's position in g' band</description><unit>mag</unit><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.926875" g-colstat:max-value="34.56" g-colstat:median="25.3519" g-colstat:min-value="13.9007" g-colstat:percentile03="20.767" g-colstat:percentile97="28.0047"><name>magisor</name><description>Isophotal magnitude in the r' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.926875" g-colstat:max-value="99.9496" g-colstat:median="0.0594524" g-colstat:min-value="9.73191e-05" g-colstat:percentile03="0.0038238" g-colstat:percentile97="0.547194"><name>magisoerrr</name><description>RMS error of isophotal magnitude in the r' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.959629" g-colstat:max-value="35.7546" g-colstat:median="24.4194" g-colstat:min-value="15.3785" g-colstat:percentile03="20.8004" g-colstat:percentile97="26.2465"><name>magaprr</name><description>Fixed aperture magnitude in the r' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.959629" g-colstat:max-value="98.759" g-colstat:median="0.0521754" g-colstat:min-value="0.000166495" g-colstat:percentile03="0.0033001" g-colstat:percentile97="0.476752"><name>magaprerrr</name><description>RMS error of fixed aperture magnitude in the r' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.986994" g-colstat:max-value="135.407" g-colstat:median="27.3408" g-colstat:min-value="20.7597" g-colstat:percentile03="26.6905" g-colstat:percentile97="27.8543"><name>maglimr</name><description>Limiting magnitude at object's position in r' band</description><unit>mag</unit><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.985109" g-colstat:max-value="32.5896" g-colstat:median="24.7306" g-colstat:min-value="12.3968" g-colstat:percentile03="20.0663" g-colstat:percentile97="27.0479"><name>magisoi</name><description>Isophotal magnitude in the i' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.985109" g-colstat:max-value="49.9544" g-colstat:median="0.0258215" g-colstat:min-value="3.60199e-05" g-colstat:percentile03="0.0015663" g-colstat:percentile97="0.0895441"><name>magisoerri</name><description>RMS error of isophotal magnitude in the i' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.997653" g-colstat:max-value="35.0839" g-colstat:median="23.9153" g-colstat:min-value="16.0524" g-colstat:percentile03="20.1863" g-colstat:percentile97="25.2103"><name>magapri</name><description>Fixed aperture magnitude in the i' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.997653" g-colstat:max-value="95.0808" g-colstat:median="0.0256237" g-colstat:min-value="0.000150464" g-colstat:percentile03="0.00141671" g-colstat:percentile97="0.0930688"><name>magaprerri</name><description>RMS error of fixed aperture magnitude in the i' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.999868" g-colstat:max-value="37.5" g-colstat:median="27.5415" g-colstat:min-value="21.1211" g-colstat:percentile03="27.0228" g-colstat:percentile97="27.9539"><name>maglimi</name><description>Limiting magnitude at object's position in i' band</description><unit>mag</unit><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.975752" g-colstat:max-value="33.7902" g-colstat:median="24.4458" g-colstat:min-value="12.5043" g-colstat:percentile03="19.638" g-colstat:percentile97="27.3271"><name>magisoz</name><description>Isophotal magnitude in the z' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.975752" g-colstat:max-value="99.1276" g-colstat:median="0.0532487" g-colstat:min-value="5.97762e-05" g-colstat:percentile03="0.00260475" g-colstat:percentile97="0.476472"><name>magisoerrz</name><description>RMS error of isophotal magnitude in the z' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.962883" g-colstat:max-value="33.5017" g-colstat:median="23.5106" g-colstat:min-value="14.4588" g-colstat:percentile03="19.6917" g-colstat:percentile97="25.7914"><name>magaprz</name><description>Fixed aperture magnitude in the z' band</description><unit>mag</unit><ucd>phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.962883" g-colstat:max-value="99.5244" g-colstat:median="0.0479589" g-colstat:min-value="9.22014e-05" g-colstat:percentile03="0.00207677" g-colstat:percentile97="0.509154"><name>magaprerrz</name><description>RMS error of fixed aperture magnitude in the z' band</description><unit>mag</unit><ucd>stat.error;phot.mag;em.opt</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="0.998727" g-colstat:max-value="123.801" g-colstat:median="26.5349" g-colstat:min-value="20.5542" g-colstat:percentile03="25.9279" g-colstat:percentile97="27.0166"><name>maglimz</name><description>Limiting magnitude at object's position in z' band</description><unit>mag</unit><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="0.0971871" g-colstat:median="0.000291946" g-colstat:min-value="-0.0315746" g-colstat:percentile03="0.000159555" g-colstat:percentile97="0.000649865"><name>fwhm</name><description>Full width half max assuming a gaussian core</description><unit>deg</unit><ucd>phys.angSize</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>indexed</flag><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="78221.4" g-colstat:median="2.82839" g-colstat:min-value="-1.32913e+06" g-colstat:percentile03="1.69626" g-colstat:percentile97="6.28759"><name>fluxradius</name><description>Fraction-of-light radius</description><unit>pix</unit><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="0.0453321" g-colstat:median="8.28685e-05" g-colstat:min-value="2.58341e-05" g-colstat:percentile03="3.90958e-05" g-colstat:percentile97="0.000253928"><name>majoraxis</name><description>Profile RMS along major axis</description><unit>deg</unit><ucd>phys.angSize.smajAxis</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="0.013261" g-colstat:median="6.21943e-05" g-colstat:min-value="6.70848e-06" g-colstat:percentile03="2.31541e-05" g-colstat:percentile97="0.000174459"><name>minoraxis</name><description>Profile RMS along minor axis</description><unit>deg</unit><ucd>phys.angSize.sminAxis</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="90" g-colstat:median="0.310081" g-colstat:min-value="-90" g-colstat:percentile03="-86.149" g-colstat:percentile97="86.3225"><name>theta</name><description>Position angle (east of north) (J2000)</description><unit>deg</unit><ucd>pos.posAng</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="0.99991" g-colstat:median="0.176322" g-colstat:min-value="4.62885e-05" g-colstat:percentile03="0.000301955" g-colstat:percentile97="0.978852"><name>sgclass</name><description>S/G classifier output (0..1)</description><ucd>src.class.starGalaxy</ucd><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="1" g-colstat:median="0" g-colstat:min-value="0" g-colstat:percentile03="0" g-colstat:percentile97="1"><name>extflags</name><description>Extraction Flags</description><dataType xsi:type="vs:VOTableType">int</dataType></column><column><name>mask</name><description>True if object is within an object mask</description><ucd>meta.code</ucd><dataType xsi:type="vs:VOTableType">boolean</dataType></column><column g-colstat:fillFactor="1" g-colstat:max-value="3.9" g-colstat:median="0.66" g-colstat:min-value="0.02" g-colstat:percentile03="0.14" g-colstat:percentile97="3.9"><name>z_b</name><description>Photometric redshift</description><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="6" g-colstat:median="2.667" g-colstat:min-value="1" g-colstat:percentile03="1" g-colstat:percentile97="5.333"><name>t_b</name><description>Mask value</description><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="1" g-colstat:median="0.81591" g-colstat:min-value="0.04351" g-colstat:percentile03="0.2943" g-colstat:percentile97="0.99981"><name>odds</name><description>Confidence parameter for photometric redshift</description><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column g-colstat:fillFactor="1" g-colstat:max-value="5" g-colstat:median="5" g-colstat:min-value="0" g-colstat:percentile03="1" g-colstat:percentile97="5"><name>ngoodfilters</name><description>Number of filters with good photometry for BPZ</description><ucd>meta.code.qual</ucd><dataType xsi:type="vs:VOTableType">int</dataType></column><column g-colstat:fillFactor="1" g-colstat:max-value="5" g-colstat:median="0" g-colstat:min-value="0" g-colstat:percentile03="0" g-colstat:percentile97="2"><name>nbadfilters</name><description>Number of filters with bad photometry for BPZ</description><ucd>meta.code.qual</ucd><dataType xsi:type="vs:VOTableType">int</dataType></column><column g-colstat:fillFactor="1" g-colstat:max-value="5" g-colstat:median="0" g-colstat:min-value="0" g-colstat:percentile03="0" g-colstat:percentile97="3"><name>nfaintfilters</name><description>Number of filters with faint photometry for BPZ</description><ucd>meta.code.qual</ucd><dataType xsi:type="vs:VOTableType">int</dataType></column><column><name>goodfilters</name><description>Filters with faint photometry for BPZ</description><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>badfilters</name><description>Filters with bad photometry for BPZ</description><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>faintfilters</name><description>Filters with faint photometry for BPZ</description><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column><column><name>fieldkey</name><description>CARS field designation</description><ucd>meta.id</ucd><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>nullable</flag></column></table></schema><schema><name>carsarcs</name><title>Gravitational arc candidates in the CFHTLS-Archive-Research Survey CARS Candidate gravitational arcs in the 37 deg^2 of CFHTLS-Archive-Research Survey (CARS). The data include their post-stamp images, astrometry, photometry (u*,g',r',i'), geometric @@ -288,9 +295,9 @@ Lipovetski and J.A. Stepanian in 1965-1980 with the Byurakan Observatory FBS plate contains low-dispersion spectra of some 15,000-20,000 objects; the whole survey consists of about 20,000,000 objects.dfbsspec.raw_spectra Raw metadata for the spectra, to be combined with image metadata like date_obs and friends for a complete spectrum descriptions. This also -contains spectral and flux points in array-valued columns.24000000accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexedprimaryplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableobjectidSynthetic object id assigned by DFBS.meta.idcharnullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullableskySky background estimation from the scan (uncalibrated).instr.skyLevelfloatnullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullablepx_lengthNumber of points in this spectrumfloatnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharindexednullable
dfbsspec.ssaA view providing standard SSA metadata for DBFS metadata in -dfbsspec.spectra23213283accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullable
dfbsspec.spectraThis table contains basic metadata as well as the spectra from the -Digital First Byurakan Survey (DFBS).accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablepx_lengthNumber of points in this spectrumfloatnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullableepochDate of observation from WFPDB (this probably does not include the time).dtime.epochdoubleindexednullableexptimeExposure time from WFPDB.stime.duration;obs.exposurefloatnullableemulsionEmulsion used in this plate from WFPDB.instr.plate.emulsioncharnullablespectralSpectral points of the extracted spectrum (wavelengths) as an array (the points are the same for all spectra; the array in this column is cropped at the blue end to match the length of flux).mem.wlfloatnullablecutout_linkCutout of the image this spectrum was extracted frommeta.ref.urlcharnullable
dmubinDelta-mu BinariesA collection of binary stars with a difference in instantaneous proper +contains spectral and flux points in array-valued columns.24000000accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexedprimaryplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableobjectidSynthetic object id assigned by DFBS.meta.idcharnullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullableskySky background estimation from the scan (uncalibrated).instr.skyLevelfloatnullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullablepx_lengthNumber of points in this spectrumfloatnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharindexednullabledfbsspec.spectraThis table contains basic metadata as well as the spectra from the +Digital First Byurakan Survey (DFBS).accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablepx_lengthNumber of points in this spectrumfloatnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullableepochDate of observation from WFPDB (this probably does not include the time).dtime.epochdoubleindexednullableexptimeExposure time from WFPDB.stime.duration;obs.exposurefloatnullableemulsionEmulsion used in this plate from WFPDB.instr.plate.emulsioncharnullablespectralSpectral points of the extracted spectrum (wavelengths) as an array (the points are the same for all spectra; the array in this column is cropped at the blue end to match the length of flux).mem.wlfloatnullablecutout_linkCutout of the image this spectrum was extracted frommeta.ref.urlcharnullable
dfbsspec.ssaA view providing standard SSA metadata for DBFS metadata in +dfbsspec.spectra23213283accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullable
dmubinDelta-mu BinariesA collection of binary stars with a difference in instantaneous proper motion as measured by HIPPARCOS and the long-term proper motion.dmubin.mainA collection of binary stars with a difference in instantaneous proper motion as measured by HIPPARCOS and the long-term proper motion.8039hipnoCatalog number in Hipparcos catalogmeta.id;meta.mainintraj2000Right ascension from Hipparcosdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination from Hipparcosdegpos.eq.dec;meta.maindoubleindexednullablecompComponent for resolved binariesmeta.codecharnullablemvVisual magnitudemagphot.mag;em.opt.VfloatnullablecolorColor index B-V, Hipparcos V magnitudemagphot.color;em.opt.B;em.opt.VfloatnullableparallaxParallax from Hipparcosmaspos.parallax.trigfloatnullableffhF-Measure for proper motions FK5 vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullablef0fF-measure for proper motions from FK5 vs. mu0Fstat.fit.goodness;pos.pm;arith.difffloatnullablef0hF-measure for proper motions from Hipparcos vs. mu0Fstat.fit.goodness;pos.pm;arith.difffloatnullablef0gchF-measure for proper motions from Hipparcos vs. mu0Gstat.fit.goodness;pos.pm;arith.difffloatnullableft2hF-measure for proper motions from Hipparcos vs. Tycho-2stat.fit.goodness;pos.pm;arith.difffloatnullablefmaxMaximum of F-measures reportedstat.fit.goodness;pos.pm;arith.difffloatnullablefkFK Part the star was found inmeta.refcharnullablegcStar Identifier in the GCmeta.id.crossintnullablet2Object is in Tycho-2meta.codebooleanhdStar Identifier in the HD-Cataloguemeta.id.crossintnullablehrStar Identifier in the HR-Cataloguemeta.id.crossintnullablecns4Star Identifier in CNS4meta.id.crosscharnullablefknoStar Identifier in the FKmeta.id.crossintnullablestar_nameName of the starmeta.idcharnullableccdmStar Identifier in the CCDM-Cataloguemeta.id.crosscharnullable
emiVLBI images of Lockman Hole radio sources These are 1.4GHz Very Long Baseline Interferometry images of 532 radio sources with a flux density exceeding 100uJy as determined by @@ -326,8 +333,8 @@ statistically significant improvements of the Hipparcos data und represents a system of unprecedented accuracy for these 4150 fundamental stars. The typical mean error in pm is 0.35 mas/year for 878 basic stars, and 0.59 mas/year for the sample of the 3272 -additional stars.fk6.part1Part I of the FK6 (successor to Basic FK5)878hipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubleindexeddej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoubleindexedpmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortlocalidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharindexedprimaryraltpRight ascension in LTP modedegpos.eq.radoublenullabledeltpDeclination in LTP modedegpos.eq.decdoublenullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullableepraltpCentral epoch of RA (LTP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_raltpError in RA (LTP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdeltpCentral epoch of Dec (LTP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_deltpError in Dec (LTP)degstat.error;pos.eq.decfloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerastpRight ascension in STP modedegpos.eq.radoublenullabledestpDeclination in STP modedegpos.eq.decdoublenullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullableeprastpCentral epoch of RA (STP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rastpError in RA (STP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdestpCentral epoch of Dec (STP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_destpError in Dec (STP)degstat.error;pos.eq.decfloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerahipRight ascension in HIP modedegpos.eq.radoublenullabledehipDeclination in HIP modedegpos.eq.decdoublenullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullableeprahipCentral epoch of RA (HIP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rahipError in RA (HIP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdehipCentral epoch of Dec (HIP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_dehipError in Dec (HIP)degstat.error;pos.eq.decfloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxsiParallax obtained in solution SIdegpos.parallaxfloatnullablee_parallaxsiError in parallax obtained in solution SIdegstat.error;pos.parallaxfloatnullableparallaxstpParallax obtained in solution STPdegpos.parallaxfloatnullablee_parallaxstpError in parallax obtained in solution STPdegstat.error;pos.parallaxfloatnullableparallaxhipParallax obtained in solution HIPdegpos.parallaxfloatnullablee_parallaxhipError in parallax obtained in solution HIPdegstat.error;pos.parallaxfloatnullablenoteNote for this objectmeta.notecharnullable
fk6.part3Part III of the FK6 (containing stars from the FK5 extension and Rsup)3273localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharsubsampleFlag for the subsample of FK6(III) stars; BX and FX denote stars from the bright and faint FK5 extensions, respectively, RS denotes stars from RSup (1993VeARI..34....1S)meta.id;meta.datasetcharnullablehipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortpmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablehipdupHIPPARCOS indicators for a suspected visual binary; d=duplicity induced variability (H52), s=Hipparcos suspected non-single (H61), t=bothmeta.code.multipcharnullablehipfitqualHIPPARCOS goodness-of-fit parameter (HIP Field H30, F2); A large value of F2 (e.g. larger than 3) may be caused by a duplicity of the object, but other reasons cannot be excluded. NULL means a negative goodness-of-fit in HIP.meta.code.qualshortnullablespeckleflagIndications on binarity provided by the catalogue of speckle observations (1999AJ....117.1890M); b=binarity resolved, u=possibly resolved, n=object observed but not resolvedmeta.code.multipcharnullableviscompIndicator for a star which has one (or more) visual component(s) with a separation rho of at least 60 arcsec.meta.code.multipcharnullablebinindsrvIndications for binarity provided by radial velocities from various sources (see Note)meta.code.multipcharnullablebinindeclIndicators for binarity from photometric variability (a=Algol-type, b=β Lyr-type, e=uncertain type, w=W UMa type)meta.code;src.varcharnullablepulsatingIndicator for a variability of the radial velocity V_rad due to stellar pulsation (which may be confused with a variability of V_rad due to spectroscopic binarity; c=Cepheid, s=δ Sct, b=β Cep)meta.code;src.varcharnullablenoteNote for this objectmeta.notecharnullable
fk6.fk6joinThe union of all published parts of FK6, comprising only the common -fields.4151localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharhipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortnoteNote for this objectmeta.notecharnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
flare_surveyPlates From Münster Flare Star Survey 1986-1991 From 1986 through 1991, the Astronomical Institute of Münster +additional stars.fk6.fk6joinThe union of all published parts of FK6, comprising only the common +fields.4151localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharhipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortnoteNote for this objectmeta.notecharnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
fk6.part1Part I of the FK6 (successor to Basic FK5)878hipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubleindexeddej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoubleindexedpmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortlocalidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharindexedprimaryraltpRight ascension in LTP modedegpos.eq.radoublenullabledeltpDeclination in LTP modedegpos.eq.decdoublenullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullableepraltpCentral epoch of RA (LTP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_raltpError in RA (LTP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdeltpCentral epoch of Dec (LTP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_deltpError in Dec (LTP)degstat.error;pos.eq.decfloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerastpRight ascension in STP modedegpos.eq.radoublenullabledestpDeclination in STP modedegpos.eq.decdoublenullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullableeprastpCentral epoch of RA (STP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rastpError in RA (STP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdestpCentral epoch of Dec (STP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_destpError in Dec (STP)degstat.error;pos.eq.decfloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerahipRight ascension in HIP modedegpos.eq.radoublenullabledehipDeclination in HIP modedegpos.eq.decdoublenullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullableeprahipCentral epoch of RA (HIP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rahipError in RA (HIP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdehipCentral epoch of Dec (HIP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_dehipError in Dec (HIP)degstat.error;pos.eq.decfloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxsiParallax obtained in solution SIdegpos.parallaxfloatnullablee_parallaxsiError in parallax obtained in solution SIdegstat.error;pos.parallaxfloatnullableparallaxstpParallax obtained in solution STPdegpos.parallaxfloatnullablee_parallaxstpError in parallax obtained in solution STPdegstat.error;pos.parallaxfloatnullableparallaxhipParallax obtained in solution HIPdegpos.parallaxfloatnullablee_parallaxhipError in parallax obtained in solution HIPdegstat.error;pos.parallaxfloatnullablenoteNote for this objectmeta.notecharnullable
fk6.part3Part III of the FK6 (containing stars from the FK5 extension and Rsup)3273localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharsubsampleFlag for the subsample of FK6(III) stars; BX and FX denote stars from the bright and faint FK5 extensions, respectively, RS denotes stars from RSup (1993VeARI..34....1S)meta.id;meta.datasetcharnullablehipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortpmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablehipdupHIPPARCOS indicators for a suspected visual binary; d=duplicity induced variability (H52), s=Hipparcos suspected non-single (H61), t=bothmeta.code.multipcharnullablehipfitqualHIPPARCOS goodness-of-fit parameter (HIP Field H30, F2); A large value of F2 (e.g. larger than 3) may be caused by a duplicity of the object, but other reasons cannot be excluded. NULL means a negative goodness-of-fit in HIP.meta.code.qualshortnullablespeckleflagIndications on binarity provided by the catalogue of speckle observations (1999AJ....117.1890M); b=binarity resolved, u=possibly resolved, n=object observed but not resolvedmeta.code.multipcharnullableviscompIndicator for a star which has one (or more) visual component(s) with a separation rho of at least 60 arcsec.meta.code.multipcharnullablebinindsrvIndications for binarity provided by radial velocities from various sources (see Note)meta.code.multipcharnullablebinindeclIndicators for binarity from photometric variability (a=Algol-type, b=β Lyr-type, e=uncertain type, w=W UMa type)meta.code;src.varcharnullablepulsatingIndicator for a variability of the radial velocity V_rad due to stellar pulsation (which may be confused with a variability of V_rad due to spectroscopic binarity; c=Cepheid, s=δ Sct, b=β Cep)meta.code;src.varcharnullablenoteNote for this objectmeta.notecharnullable
flare_surveyPlates From Münster Flare Star Survey 1986-1991 From 1986 through 1991, the Astronomical Institute of Münster University performed a search for flare stars in several southern associations and open stellar clusters using the GPO telescope (d=40 cm, WFPDB identifier ESO040); the fields suveyed include Coalsack, @@ -363,33 +370,38 @@ using a transparent filter that nearly equals the no-filter throughput and thus provides a high signal-to-noise ratio. Based on an approximate conversion to V-band magnitudes, the unbinned and binned mosaics (0.24 and 0.71 arcsec/pixel) reach a median depth of 26.6 and -27.8 mag/sq.arcsec, respectively.2accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullabledidGlobally unique IVOA publisher DID for this dataset.meta.idcharnullabledatalink_urlURL to a datalink document for this mosaic (ancillary files, cutouts)meta.ref.urlcharnullablegaiaSelections from Gaia Data Release 2 (DR2) +27.8 mag/sq.arcsec, respectively.2accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullabledidGlobally unique IVOA publisher DID for this dataset.meta.idcharnullabledatalink_urlURL to a datalink document for this mosaic (ancillary files, cutouts)meta.ref.urlcharnullablegaiaSelections from Gaia Data Release 3 (DR3) This schema contains data re-published from the official Gaia mirrors (such as ivo://uni-heidelberg.de/gaia/tap) either to support combining its data with local tables (the various Xlite tables) or to make the data more accessible to VO clients (e.g., epoch fluxes). -Other Gaia-related data is found in, among others, the gdr2dist, gdr3mock, -gdr3spec, gedr3auto, gedr3dist, gedr3mock, and gedr3spur schemas.gaia.dr3liteGaia DR3 source catalogue "light" This is gaia_source from the Gaia Data Release 3, stripped to just -enough columns to enable basic science (but therefore a bit faster and -simpler to deal with than the full gaia_source table). +Other Gaia-related data is found in, among others, the gdr3mock, +gdr3spec, gedr3auto, gedr3dist, gedr3mock, and gedr3spur schemas.
gaia.dr2_ts_ssaGaia DR2 Timeseries SSA Table This table contains about 1.5 Million photometric timeseries for +roughly 0.5 Million objects. Photometry is available in the Gaia G, +BP, and RP bands for epochs between 2014-07-25 and 2016-05-25. The +spectra are available in VOTable format with the timeseries annotation +proposed in the Nadvornik et al IVOA note.1700000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullabletime_minFirst timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.mindoubleindexednullabletime_maxLast timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.maxdoubleindexednullable
gaia.dr2epochfluxGaia DR2 epoch fluxes +A table of the light curves released with Gaia DR2 (about half a million +in total). In each Gaia band (G, BP, RP), we give epochs, fluxes and +their errors in arrays. We do not include the quality flags (DR2: “may +be safely ignored for many general purpose applications”). You can +access them through the associated datalink service if you select +source_id. You will usually join this table with gaia.dr2light. -Note that on this server, there is also The gedr3dist.main, which -gives distances computed by Bailer-Jones et al. Use these in -preference to working with the raw parallaxes. +We have also removed all entries with NaN observation times; hence, +the array lengths in the different bands can be significantly different, +and the indices in transit_ids do not always correspond to the +indices in the time series. -This server also carries the gedr3mock schema containing a simulation -of gaia_source based on a state-of-the-art galaxy model, computed by -Rybizki et al. +Furthermore, we only give fluxes and their errors here rather than +magnitudes. Fluxes can be turned into magnitude using:: -The full DR3 is available from numerous places in the VO (in -particular from the TAP services ivo://uni-heidelberg.de/gaia/tap and -ivo://esavo/gaia/tap).1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.edr3liteGaia eDR3 source catalogue "light" This is a “light” version of the full Gaia DR3 gaia_source table. It -is just a view copying gaia.dr3lite, which should preferentially be -used in new queries. This table is being kept around in order to keep -legacy queries from breaking unnecessarily. However, it is actually -DR3 data rather than eDR3. The minute differences did not seem to -warrant keeping two copies of the relatively massive data around.1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.dr2lightGaia DR2 source catalogue "light" + mag = -2.5 log10(flux)+zero point, + +where the zero points assumed for Gaia DR2 are +25.6884±0.0018 in G, 25.3514±0.0014 in BP, and +24.7619±0.0019 in RP (VEGAMAG).550737source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimarytransit_idTransit unique identifier. For a given object, a transit comprises the different Gaia observations (SM, AF, BP, RP and RVS) obtained for each focal plane crossing. NOTE: Where invalid observations have been removed, transit_id *cannot* be joined with times and fluxes.meta.versionlongnullableg_transit_timeThe field-of-view transit averaged observation times for the G-band observations. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullableg_transit_fluxG-band fluxes for the transit, for combination with g_transit_time_mjd. Here, this is a combination of individual SM-AF CCD fluxess**-1phot.flux;em.opt.Vfloatnullableg_transit_flux_errorThe error in G-band flux.s**-1stat.error;phot.flux;em.opt.Vfloatnullablerp_obs_timeThe observation time of the RP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablerp_fluxRP-band integrated fluxes, for combination with rp_obs_times**-1phot.flux;em.opt.Rfloatnullablerp_flux_errorThe error in RP-band flux.s**-1stat.error;phot.flux;em.opt.Rfloatnullablebp_obs_timeThe observation time of the BP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablebp_fluxBP-band integrated fluxes, for combination with bp_obs_times**-1phot.flux;em.opt.Bfloatnullablebp_flux_errorThe error in BP-band flux.s**-1stat.error;phot.flux;em.opt.Bfloatnullablesolution_idA DPAC id for the toolchain used to produce these particular time series. It is given to facilitate comparison with ESAC data products.meta.versionlonggaia.dr2lightsource_idsource_id
gaia.dr2lightGaia DR2 source catalogue "light" This is a “light” version of the full Gaia DR2 gaia_source table, containing the original astrometric and photmetric columns with just enough additional information to let careful researchers notice when data @@ -404,31 +416,26 @@ consistency of the solution. On this TAP service, there is the table gdr2dist.main containing distances computed by Bailer-Jones et al (:bibcode:`2018AJ....156...58B`). -If in doubt, use these instead of the parallaxes provided here.1600000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codefloatnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.dr2epochfluxGaia DR2 epoch fluxes -A table of the light curves released with Gaia DR2 (about half a million -in total). In each Gaia band (G, BP, RP), we give epochs, fluxes and -their errors in arrays. We do not include the quality flags (DR2: “may -be safely ignored for many general purpose applications”). You can -access them through the associated datalink service if you select -source_id. You will usually join this table with gaia.dr2light. - -We have also removed all entries with NaN observation times; hence, -the array lengths in the different bands can be significantly different, -and the indices in transit_ids do not always correspond to the -indices in the time series. +If in doubt, use these instead of the parallaxes provided here.1600000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codefloatnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.dr3liteGaia DR3 source catalogue "light" This is gaia_source from the Gaia Data Release 3, stripped to just +enough columns to enable basic science (but therefore a bit faster and +simpler to deal with than the full gaia_source table). -Furthermore, we only give fluxes and their errors here rather than -magnitudes. Fluxes can be turned into magnitude using:: +Note that on this server, there is also The gedr3dist.main, which +gives distances computed by Bailer-Jones et al. Use these in +preference to working with the raw parallaxes. - mag = -2.5 log10(flux)+zero point, +This server also carries the gedr3mock schema containing a simulation +of gaia_source based on a state-of-the-art galaxy model, computed by +Rybizki et al. -where the zero points assumed for Gaia DR2 are -25.6884±0.0018 in G, 25.3514±0.0014 in BP, and -24.7619±0.0019 in RP (VEGAMAG).550737source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimarytransit_idTransit unique identifier. For a given object, a transit comprises the different Gaia observations (SM, AF, BP, RP and RVS) obtained for each focal plane crossing. NOTE: Where invalid observations have been removed, transit_id *cannot* be joined with times and fluxes.meta.versionlongnullableg_transit_timeThe field-of-view transit averaged observation times for the G-band observations. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullableg_transit_fluxG-band fluxes for the transit, for combination with g_transit_time_mjd. Here, this is a combination of individual SM-AF CCD fluxess**-1phot.flux;em.opt.Vfloatnullableg_transit_flux_errorThe error in G-band flux.s**-1stat.error;phot.flux;em.opt.Vfloatnullablerp_obs_timeThe observation time of the RP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablerp_fluxRP-band integrated fluxes, for combination with rp_obs_times**-1phot.flux;em.opt.Rfloatnullablerp_flux_errorThe error in RP-band flux.s**-1stat.error;phot.flux;em.opt.Rfloatnullablebp_obs_timeThe observation time of the BP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablebp_fluxBP-band integrated fluxes, for combination with bp_obs_times**-1phot.flux;em.opt.Bfloatnullablebp_flux_errorThe error in BP-band flux.s**-1stat.error;phot.flux;em.opt.Bfloatnullablesolution_idA DPAC id for the toolchain used to produce these particular time series. It is given to facilitate comparison with ESAC data products.meta.versionlonggaia.dr2lightsource_idsource_id
gaia.dr2_ts_ssaGaia DR2 Timeseries SSA Table This table contains about 1.5 Million photometric timeseries for -roughly 0.5 Million objects. Photometry is available in the Gaia G, -BP, and RP bands for epochs between 2014-07-25 and 2016-05-25. The -spectra are available in VOTable format with the timeseries annotation -proposed in the Nadvornik et al IVOA note.1700000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullabletime_minFirst timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.mindoubleindexednullabletime_maxLast timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.maxdoubleindexednullable
gcnsThe Gaia eDR3 Catalogue of Nearby Stars GCNS +The full DR3 is available from numerous places in the VO (in +particular from the TAP services ivo://uni-heidelberg.de/gaia/tap and +ivo://esavo/gaia/tap).1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullablegaia.edr3liteGaia eDR3 source catalogue "light" This is a “light” version of the full Gaia DR3 gaia_source table. It +is just a view copying gaia.dr3lite, which should preferentially be +used in new queries. This table is being kept around in order to keep +legacy queries from breaking unnecessarily. However, it is actually +DR3 data rather than eDR3. The minute differences did not seem to +warrant keeping two copies of the relatively massive data around.1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gcnsThe Gaia eDR3 Catalogue of Nearby Stars GCNS This is a clean and well characterised catalogue of objects within 100pc of the Sun from the Gaia early third data release. We characterise the catalogue using the full data release, and comparisons to other catalogues @@ -443,20 +450,7 @@ within 100 pc at spectral type M9. GCNS comes with several auxiliary tables, in particular lists of resolved stellar systems, of known neary stars not found in eDR3 and -of candidates of Hyades and ComaBer cluster members.gcns.maineDR3 Gaia Catalogue of Nearby Stars (GCNS)This is the main catalogue. Additional resources include: -gcns.resolvedss (resolved stellar systems), gcns.missing_10mas -(objects missing from eDR3 that have been suspected of being within -100 pc before), and gcns.hyacob (probable members of the Hyades and -the Coma Berenices open cluster).331312source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.rejectedeDR3 GCNS: Rejected ObjectsThis is the catalogue of objects in the 8mas sample that were rejected -for the main Gaia Catalogue of Nearby Stars as having a zero -probability of being inside 100pc or indicated as a spurious -astrometric solution.source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.resolvedsseDR3 GCNS Resolved Binary Candidates -Resolved binary candidates in the GCNS catalogue as discussed in -https://doi.org/10.1051/0004-6361/202039498, “stellar multiplicity: -resolved systems”. You probably want to join this table to gaia.edr3lite -using source_id1 and/or source_id2.19176source_id1Gaia EDR3 source_id of the primary starmeta.id.partlongsource_id2Gaia EDR3 source_id of secondary startmeta.id.partlongseparationAngular separation of the two sources.arcsecpos.angDistancefloatnullablemag_diffG magnitude difference between the two componentsmagphot.mag;arith.diff;em.opt.Vfloatnullableproj_sepProjected separation of the pairAUphys.sizefloatnullablebin1 if the system is probably made up of more than two stars, 0 otherwise.meta.code.multipshortbound1 if the system is probably gravitationally bound, 0 otherwisemeta.codeshort
gcns.missing_10maseDR3 GCNS list of possibly nearby stars missingA table of 1258 objects with published parallaxes greater than 10mas -that are not or have no parallax in Gaia eDR3 and are hence not listed -in gcns.main.1259main_idSource name from Simbadmeta.id;meta.maincharnullableraICRS RA from Simbaddegpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec from Simbaddegpos.eq.dec;meta.maindoubleindexednullableplx_valueParallax from Simbadmaspos.parallaxfloatnullableplx_bibcodeSource reference for the parallaxmeta.bib.bibcodecharnullableotypeSimbad object typemeta.code.classcharnullable
gcns.hyacobeDR3 GCNS open cluster membership table A list of 920+212 probable Hyades and ComaBer members in the eDR3 +of candidates of Hyades and ComaBer cluster members.
gcns.hyacobeDR3 GCNS open cluster membership table A list of 920+212 probable Hyades and ComaBer members in the eDR3 GCNS sample.1132source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullablenameName of the cluster this object probably belongs tometa.idcharnullablec_clusterDimensionless chi-square test statistic. Small values indicate highly probable members (cf. eq. 4 in 2018MNRAS.477.3197R)stat.likelihoodfloatnullabledist_clusterDistance of each star from the cluster barycentre.pcpos.distancefloatnullablegcns.mainsource_idsource_id
gcns.maglims5Magnitude distribution over 5-HEALPixes The G magnitude distribution percentiles per level 5 HEALpixes for all Gaia sources with a parallax and a G magnitude measurement. Can be used to approximate the G magnitude limit for Gaia at that position of @@ -478,7 +472,20 @@ the sky. Sources up to a limiting magnitude equal to 'magnitude_70' are 98% complete when compared to PS1. The 80th and 90th percentile decrease the completeness in Gaia to 97% and 95%, respectively. These cuts can be very useful, when trying to compare Gaia data to models, -e.g. the GeDR3mock catalog (gedrmock.main).196608hpxHEALPix on level 7 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcpmsStellar Proper Motions in the Ogle II Galactic Bulge FieldsA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic +e.g. the GeDR3mock catalog (gedrmock.main).196608hpxHEALPix on level 7 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberintgcns.maineDR3 Gaia Catalogue of Nearby Stars (GCNS)This is the main catalogue. Additional resources include: +gcns.resolvedss (resolved stellar systems), gcns.missing_10mas +(objects missing from eDR3 that have been suspected of being within +100 pc before), and gcns.hyacob (probable members of the Hyades and +the Coma Berenices open cluster).331312source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.missing_10maseDR3 GCNS list of possibly nearby stars missingA table of 1258 objects with published parallaxes greater than 10mas +that are not or have no parallax in Gaia eDR3 and are hence not listed +in gcns.main.1259main_idSource name from Simbadmeta.id;meta.maincharnullableraICRS RA from Simbaddegpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec from Simbaddegpos.eq.dec;meta.maindoubleindexednullableplx_valueParallax from Simbadmaspos.parallaxfloatnullableplx_bibcodeSource reference for the parallaxmeta.bib.bibcodecharnullableotypeSimbad object typemeta.code.classcharnullable
gcns.rejectedeDR3 GCNS: Rejected ObjectsThis is the catalogue of objects in the 8mas sample that were rejected +for the main Gaia Catalogue of Nearby Stars as having a zero +probability of being inside 100pc or indicated as a spurious +astrometric solution.source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.resolvedsseDR3 GCNS Resolved Binary Candidates +Resolved binary candidates in the GCNS catalogue as discussed in +https://doi.org/10.1051/0004-6361/202039498, “stellar multiplicity: +resolved systems”. You probably want to join this table to gaia.edr3lite +using source_id1 and/or source_id2.19176source_id1Gaia EDR3 source_id of the primary starmeta.id.partlongsource_id2Gaia EDR3 source_id of secondary startmeta.id.partlongseparationAngular separation of the two sources.arcsecpos.angDistancefloatnullablemag_diffG magnitude difference between the two componentsmagphot.mag;arith.diff;em.opt.Vfloatnullableproj_sepProjected separation of the pairAUphys.sizefloatnullablebin1 if the system is probably made up of more than two stars, 0 otherwise.meta.code.multipshortbound1 if the system is probably gravitationally bound, 0 otherwisemeta.codeshort
gcpmsStellar Proper Motions in the Ogle II Galactic Bulge FieldsA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic bulge (GB) fields, covering a range of -11°<l<11° and -6°<b<3°. Some columns have been left out from the original source.gcpms.dataA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic bulge (GB) fields, covering a range of -11°<l<11° and -6°<b<3°. Some @@ -532,10 +539,10 @@ Galaxia (a tool to sample stars from a Besancon-like Milky Way model), mimicking the Gaia DR2 data model and an apparent magnitude limit of g=20,7. Extinctions and photometry in different bands have also been included in a supplementary table as well as uncertainty estimates -using a scaled nominal error model.
gdr2mock.photometryPhotometry for the Gaia DR2 mock catalogThis table contains simulated absolute magnitudes to about 0.1 mag +using a scaled nominal error model.
gdr2mock.mainA synthetic Milky Way catalog mimicking GDR2 in stellar content and +data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoubleindexednullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoubleindexednullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_magApproximate estimate for the RVS magnitude. This uses formulae (2) and (3) from 2018A&A...616A...1G. Outside of the range 0.1<BP-G<1.7 we use Eq. 3 (which means the value is probably fairly bogus).magphot.color;em.opt.Ifloatnullablerv_nb_transitsNumber of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epochReference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_qHipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noiseExcess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sigSignificance of excess noisestat.valuefloatnullableastrometric_n_obs_acTotal number of observations ACmeta.numbershortastrometric_n_obs_alTotal number of observations ALmeta.numbershortastrometric_n_bad_obs_acNumber of bad observations ACmeta.numbershortastrometric_n_bad_obs_alNumber of bad observations ALmeta.numbershortastrometric_n_good_obs_acNumber of good observations ACmeta.numbershortastrometric_n_good_obs_alNumber of good observations ALmeta.numbershortastrometric_chi2_alAstrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flagOnly primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colourColour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_alMean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisiblilty_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_maxThe longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observationsThe number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_usedType of prior used in in the astrometric solutionshortnullableastrometric_relegation_factorRelegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_acMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_alMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_sourceDuring data processing, this source happened to have been duplicated and one source only has been kept.shortra_dec_corrCorrelation between right ascension and declinationstat.correlationfloatnullablera_pmra_corrCorrelation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corrCorrelation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corrCorrelation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corrCorrelation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corrCorrelation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corrCorrelation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corrCorrelation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corrCorrelation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corrCorrelation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4Degree of concentration of scan directions across the sourcefloatnullablepriam_flagsFlags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flagsFlags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lowerLower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upperUpper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lowerLower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upperUpper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lowerLower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upperUpper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lowerLower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upperUpper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lowerLower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upperUpper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefehFe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullablemassInitial mass of the starsolMassphys.massfloatnullableageAge of the starGyrtime.agefloatnullableloggLogarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablenobsNominal number of observations, scaled to the shorter time base of GDR2 (a function with ecliptic latitude).meta.number;obsintindex_parsecForeign key into the photometry/extinction table.meta.id.crossintgdr2mock.photometryindex_parsecindex_parsec
gdr2mock.photometryPhotometry for the Gaia DR2 mock catalogThis table contains simulated absolute magnitudes to about 0.1 mag precision for all the stars, as well as extinctions in several bands; -To use it, join it USING (parsec_index) with the gdr2mock.main table.mag_gaia_gSimulated absolute magnitude in the Gaia G band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_uSimulated absolute magnitude in the Johnson U band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_ubv_bSimulated absolute magnitude in the Johnson B band (note that no extinction is applied).magphot.mag;em.opt.Bfloatnullablemag_ubv_vSimulated absolute magnitude in the Johnson V band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_rSimulated absolute magnitude in the Johnson R band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_ubv_iSimulated absolute magnitude in the Johnson I band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_ubv_jSimulated absolute magnitude in the Johnson J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_ubv_hSimulated absolute magnitude in the Johnson H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_ubv_kSimulated absolute magnitude in the Johnson K band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_sdss_uSimulated absolute magnitude in the SDSS u band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_sdss_gSimulated absolute magnitude in the SDSS g band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_sdss_rSimulated absolute magnitude in the SDSS r band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_sdss_iSimulated absolute magnitude in the SDSS i band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_sdss_zSimulated absolute magnitude in the SDSS z band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_2mass_jSimulated absolute magnitude in the 2MASS J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_2mass_hSimulated absolute magnitude in the 2MASS H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_2mass_ksSimulated absolute magnitude in the 2MASS K' band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_wise_w1Simulated absolute magnitude in the WISE W1 band (note that no extinction is applied).magphot.mag;em.ir.3-4umfloatnullablemag_wise_w2Simulated absolute magnitude in the WISE W2 band (note that no extinction is applied).magphot.mag;em.ir.4-8umfloatnullablemag_wise_w3Simulated absolute magnitude in the WISE W3 band (note that no extinction is applied).magphot.mag;em.ir.8-15umfloatnullablemag_wise_w4Simulated absolute magnitude in the WISE W4 band (note that no extinction is applied).magphot.mag;em.ir.15-30umfloatnullableindex_parsecThe parsec bin has the format AABBCCCDDD, where AA denotes the metallicity bin, BB the luminosity bin, CCC the T_eff bin, and DDD the extinction bin.meta.id;meta.maininta_bpExtinction in the Gaia BP bandmagphys.absorption;em.opt.Bfloatnullablea_rpExtinction in the Gaia RP bandmagphys.absorption;em.opt.Rfloatnullablea_juExtinction in the Johnson U bandmagphys.absorption;em.opt.Ufloatnullablea_jbExtinction in the Johnson B bandmagphys.absorption;em.opt.Bfloatnullablea_jvExtinction in the Johnson V bandmagphys.absorption;em.opt.Vfloatnullablea_jrExtinction in the Johnson R bandmagphys.absorption;em.opt.Rfloatnullablea_jiExtinction in the Johnson I bandmagphys.absorption;em.opt.Ifloatnullablea_jjExtinction in the Johnson J bandmagphys.absorption;em.ir.Jfloatnullablea_jhExtinction in the Johnson H bandmagphys.absorption;em.ir.Hfloatnullablea_jkExtinction in the Johnson K bandmagphys.absorption;em.ir.Kfloatnullablea_suExtinction in the SDSS u bandmagphys.absorption;em.opt.Ufloatnullablea_sgExtinction in the SDSS g bandmagphys.absorption;em.opt.Vfloatnullablea_srExtinction in the SDSS r bandmagphys.absorption;em.opt.Rfloatnullablea_siExtinction in the SDSS i bandmagphys.absorption;em.opt.Ifloatnullablea_szExtinction in the SDSS z bandmagphys.absorption;em.opt.Ifloatnullable
gdr2mock.mainA synthetic Milky Way catalog mimicking GDR2 in stellar content and -data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoubleindexednullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoubleindexednullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_magApproximate estimate for the RVS magnitude. This uses formulae (2) and (3) from 2018A&A...616A...1G. Outside of the range 0.1<BP-G<1.7 we use Eq. 3 (which means the value is probably fairly bogus).magphot.color;em.opt.Ifloatnullablerv_nb_transitsNumber of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epochReference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_qHipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noiseExcess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sigSignificance of excess noisestat.valuefloatnullableastrometric_n_obs_acTotal number of observations ACmeta.numbershortastrometric_n_obs_alTotal number of observations ALmeta.numbershortastrometric_n_bad_obs_acNumber of bad observations ACmeta.numbershortastrometric_n_bad_obs_alNumber of bad observations ALmeta.numbershortastrometric_n_good_obs_acNumber of good observations ACmeta.numbershortastrometric_n_good_obs_alNumber of good observations ALmeta.numbershortastrometric_chi2_alAstrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flagOnly primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colourColour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_alMean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisiblilty_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_maxThe longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observationsThe number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_usedType of prior used in in the astrometric solutionshortnullableastrometric_relegation_factorRelegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_acMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_alMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_sourceDuring data processing, this source happened to have been duplicated and one source only has been kept.shortra_dec_corrCorrelation between right ascension and declinationstat.correlationfloatnullablera_pmra_corrCorrelation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corrCorrelation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corrCorrelation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corrCorrelation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corrCorrelation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corrCorrelation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corrCorrelation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corrCorrelation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corrCorrelation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4Degree of concentration of scan directions across the sourcefloatnullablepriam_flagsFlags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flagsFlags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lowerLower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upperUpper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lowerLower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upperUpper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lowerLower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upperUpper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lowerLower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upperUpper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lowerLower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upperUpper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefehFe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullablemassInitial mass of the starsolMassphys.massfloatnullableageAge of the starGyrtime.agefloatnullableloggLogarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablenobsNominal number of observations, scaled to the shorter time base of GDR2 (a function with ecliptic latitude).meta.number;obsintindex_parsecForeign key into the photometry/extinction table.meta.id.crossintgdr2mock.photometryindex_parsecindex_parsec
gdr3specGaia DR3 RP/BP (XP) Monte Carlo sampled spectra +To use it, join it USING (parsec_index) with the gdr2mock.main table.mag_gaia_gSimulated absolute magnitude in the Gaia G band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_uSimulated absolute magnitude in the Johnson U band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_ubv_bSimulated absolute magnitude in the Johnson B band (note that no extinction is applied).magphot.mag;em.opt.Bfloatnullablemag_ubv_vSimulated absolute magnitude in the Johnson V band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_rSimulated absolute magnitude in the Johnson R band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_ubv_iSimulated absolute magnitude in the Johnson I band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_ubv_jSimulated absolute magnitude in the Johnson J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_ubv_hSimulated absolute magnitude in the Johnson H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_ubv_kSimulated absolute magnitude in the Johnson K band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_sdss_uSimulated absolute magnitude in the SDSS u band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_sdss_gSimulated absolute magnitude in the SDSS g band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_sdss_rSimulated absolute magnitude in the SDSS r band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_sdss_iSimulated absolute magnitude in the SDSS i band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_sdss_zSimulated absolute magnitude in the SDSS z band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_2mass_jSimulated absolute magnitude in the 2MASS J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_2mass_hSimulated absolute magnitude in the 2MASS H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_2mass_ksSimulated absolute magnitude in the 2MASS K' band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_wise_w1Simulated absolute magnitude in the WISE W1 band (note that no extinction is applied).magphot.mag;em.ir.3-4umfloatnullablemag_wise_w2Simulated absolute magnitude in the WISE W2 band (note that no extinction is applied).magphot.mag;em.ir.4-8umfloatnullablemag_wise_w3Simulated absolute magnitude in the WISE W3 band (note that no extinction is applied).magphot.mag;em.ir.8-15umfloatnullablemag_wise_w4Simulated absolute magnitude in the WISE W4 band (note that no extinction is applied).magphot.mag;em.ir.15-30umfloatnullableindex_parsecThe parsec bin has the format AABBCCCDDD, where AA denotes the metallicity bin, BB the luminosity bin, CCC the T_eff bin, and DDD the extinction bin.meta.id;meta.maininta_bpExtinction in the Gaia BP bandmagphys.absorption;em.opt.Bfloatnullablea_rpExtinction in the Gaia RP bandmagphys.absorption;em.opt.Rfloatnullablea_juExtinction in the Johnson U bandmagphys.absorption;em.opt.Ufloatnullablea_jbExtinction in the Johnson B bandmagphys.absorption;em.opt.Bfloatnullablea_jvExtinction in the Johnson V bandmagphys.absorption;em.opt.Vfloatnullablea_jrExtinction in the Johnson R bandmagphys.absorption;em.opt.Rfloatnullablea_jiExtinction in the Johnson I bandmagphys.absorption;em.opt.Ifloatnullablea_jjExtinction in the Johnson J bandmagphys.absorption;em.ir.Jfloatnullablea_jhExtinction in the Johnson H bandmagphys.absorption;em.ir.Hfloatnullablea_jkExtinction in the Johnson K bandmagphys.absorption;em.ir.Kfloatnullablea_suExtinction in the SDSS u bandmagphys.absorption;em.opt.Ufloatnullablea_sgExtinction in the SDSS g bandmagphys.absorption;em.opt.Vfloatnullablea_srExtinction in the SDSS r bandmagphys.absorption;em.opt.Rfloatnullablea_siExtinction in the SDSS i bandmagphys.absorption;em.opt.Ifloatnullablea_szExtinction in the SDSS z bandmagphys.absorption;em.opt.Ifloatnullablegdr3specGaia DR3 RP/BP (XP) Monte Carlo sampled spectra This is a re-publication the Gaia DR3 RP/BP spectra in the IVOA Spectral Data Model. It presents the continous spectra in sampled form, using a Monte Carlo scheme to decorrelate errors, elaborated in this resource's @@ -543,9 +550,9 @@ reference URL. The underlying tables are also available for querying through TAP, which opens some powerful methods for mass-analysing the data.gdr3spec.spectraMonte Carlo sampled DR3 XP spectraThis table contains the sampled spectra, their errors (as the standard deviation of the samples between the different realisations), and the Gaia DR3 source_id. Join this table on source_id with gaia.dr3lite to -obtain information on the sources.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryfluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gdr3spec.withposMonte Carlo Sampled DR3 XP Spectra with Basic Object InformationThis table contains the data from gdr3spec.spectra plus position and +obtain information on the sources.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryfluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gdr3spec.ssametaSSA Metadata for the Monte Carlo-sampled Gaia DR3 XP spectra219196404phot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablesource_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablepreviewURL of a preview for the datasetmeta.ref.url;meta.previewcharnullableaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharnullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoublenullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperturedoublenullable
gdr3spec.withposMonte Carlo Sampled DR3 XP Spectra with Basic Object InformationThis table contains the data from gdr3spec.spectra plus position and photometry from gaia.dr3lite. It is a view, and there is generally no -advantage to using it instead of manually performing the join.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablefluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gdr3spec.ssametaSSA Metadata for the Monte Carlo-sampled Gaia DR3 XP spectra219196404phot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablesource_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablepreviewURL of a preview for the datasetmeta.ref.url;meta.previewcharnullableaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharnullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoublenullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperturedoublenullable
gedr3autoGaia eDR3 Autocorrelation This is a table that simply gives, for each object in Gaia eDR3, the +advantage to using it instead of manually performing the join.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablefluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullablegedr3autoGaia eDR3 Autocorrelation This is a table that simply gives, for each object in Gaia eDR3, the identifier of its closest neighbour together with the distance of the pair.gedr3auto.main This is a table that simply gives, for each object in Gaia eDR3, the identifier of its closest neighbour together with the distance of the @@ -576,7 +583,17 @@ modulus, and likewise for the uncertainties. For applications that cannot be satisfied through TAP, you can download a `full table dump`_. -.. _full table dump: /gedr3dist/q/download/form
gedr3dist.main +.. _full table dump: /gedr3dist/q/download/form
gedr3dist.litewithdistGaia (e)DR3 lite distances subsetThis table joins the DR3 "lite" table +(consisting only of the columns necessary for the most basic +science) with the estimated geometric and photogeometric distances. +Note that this is an inner join, i.e., DR3 objects without +distance estimates will not show up here. + +Note: Due to current limitations of the postgres query planner, +this table cannot usefully be used in positional joins +("crossmatches"). See the `Tricking the query planner`_ example. + +.. _tricking the query planner: http://dc.g-vo.org/tap/examples#Trickingthequeryplanner1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullabler_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3dist.main We estimate the distance from the Sun to sources in Gaia eDR3 that have parallaxes. We provide two types of distance estimate, together with their corresponding asymmetric uncertainties, using Bayesian posterior @@ -602,17 +619,7 @@ modulus, and likewise for the uncertainties. For applications that cannot be satisfied through TAP, you can download a `full table dump`_. -.. _full table dump: /gedr3dist/q/download/form1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryr_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3dist.litewithdistGaia (e)DR3 lite distances subsetThis table joins the DR3 "lite" table -(consisting only of the columns necessary for the most basic -science) with the estimated geometric and photogeometric distances. -Note that this is an inner join, i.e., DR3 objects without -distance estimates will not show up here. - -Note: Due to current limitations of the postgres query planner, -this table cannot usefully be used in positional joins -("crossmatches"). See the `Tricking the query planner`_ example. - -.. _tricking the query planner: http://dc.g-vo.org/tap/examples#Trickingthequeryplanner1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullabler_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3mockGaia early DR3 Mock Catalogue (gedr3mock) This catalogue is a simulation of the Gaia EDR3 stellar content using +.. _full table dump: /gedr3dist/q/download/form1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryr_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullablegedr3mockGaia early DR3 Mock Catalogue (gedr3mock) This catalogue is a simulation of the Gaia EDR3 stellar content using Galaxia (a tool to sample stars from a Besancon-like Milky Way model), 3d dust extinction maps and the latest PARSEC Isochrones. It is mimicking the Gaia DR2 data model and an apparent magnitude limit of @@ -620,25 +627,9 @@ G=20,7. Extinctions and photometry in different bands have also been included in a supplementary table as well as uncertainty estimates using scaled GDR2 errors. Additional magnitude limit per HEALpix maps are provided, based on the mode in the magnitude distribution of Gaia -DR2 data.gedr3mock.parsec_propsParsec-based photometry and extinction for GeDR3 Mock This table is intended to augment the Gaia photometry of GeDR3 Mock -stars with other bands and extinctions (Sloan, Johnson and 2MASS). The -grid was generated by binning all isochrones in logg, teff, and feh -and taking the median values of all isochrone models that fall within -one bin. We also report the median values of some astrophysical -parameters so that one can check how far the actual star abundances -deviate from the bin's median. For the extinction we report the -extinction for the specific isochrone bin in a specific photometric -band for 6 different values of monochromatic extinction, A_0, i.e. -1,2,3,5,10,20 mag. - -Sometimes stars in GeDR3 Mock depart from the isochrone grid, because, -e.g., the feh value is outside of the grid or values have been -interpolated by Galaxia in the catalog generation from the Parsec -isochrones. Then the index_parsec is assigned to the nearest neighbour -in log_lum and log_teff.243238index_parsecThe primary key of the photometry table, useful for joining with index_parsec in gedr3mock.main. This has the format LLLTTTFFF indexing bins in log_lum, log_teff, feh in the parsec isochrones. To find the actual bin centers, see the log_lum, log_teff, and meh_ini columns.meta.refintindexedmeh_iniLog of initial model metalicity at the center of this bin.phys.abund.zfloatnullablelog_ageMedian log of model star age at the parsec bin.log(yr)time.agefloatnullablem_iniMedian of the initial (zero age) mass of all model stars in the parsec bin.solMassphys.massfloatnullablem_actMedian of the current (at log_age) mass of all model star in the parsec bin.solMassphys.massfloatnullablelog_lumMedian Log of luminosity of all model stars in the parsec bin.log(solLum)phys.luminosityfloatnullablelog_teffMedian Log of the effective temperature of all model stars in the parsec bin.log(K)phys.temperature.effectivefloatnullablelog_gravMedian Log of the surface gravity of all model stars in the parsec bin.log(m/s**2)phys.gravityfloatnullablegaia_gMedian absolute magnitude in the Gaia G band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablegaia_bpbrMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_bpftMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_rpMedian absolute magnitude in the Gaia RP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablegaia_rvsMedian absolute magnitude in the Gaia RVS band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_uMedian absolute magnitude in the Johnson U band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullableubv_bMedian absolute magnitude in the Johnson B band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullableubv_vMedian absolute magnitude in the Johnson V band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullableubv_rMedian absolute magnitude in the Johnson R band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_iMedian absolute magnitude in the Johnson I band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullableubv_jMedian absolute magnitude in the Johnson J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullableubv_hMedian absolute magnitude in the Johnson H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullableubv_kMedian absolute magnitude in the Johnson K band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullableubv_lMedian absolute magnitude in the Johnson L band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.3-4umfloatnullableubv_mMedian absolute magnitude in the Johnson M band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.4-8umfloatnullablesloan_uMedian absolute magnitude in the SDSS u band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullablesloan_gMedian absolute magnitude in the SDSS g band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablesloan_rMedian absolute magnitude in the SDSS r band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablesloan_iMedian absolute magnitude in the SDSS i band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullablesloan_zMedian absolute magnitude in the SDSS z band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullabletmass_jMedian absolute magnitude in the 2MASS J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullabletmass_hMedian absolute magnitude in the 2MASS H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullabletmass_ksMedian absolute magnitude in the 2MASS K' band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullablea0_1_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_1_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_1_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_2_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_2_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_2_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_3_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_3_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_3_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_5_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_5_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_5_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_10_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_10_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_10_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_20_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_20_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_20_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullable
gedr3mock.generated_dataThis contains the data actually generated. Users probably want to use +DR2 data.
gedr3mock.generated_dataThis contains the data actually generated. Users probably want to use the gdr2mock.main table that (fairly well) follows the Gaia DR2 data -model.1600000000teffeffective TemperatureKfloatfehlog of metallicity in solar units ('dex')floata0monochramatic Extinction at lambda=547.7nmmagfloatlumStellar luminositysolLumfloatlGalactic longitudedegdoublebGalactic latitudedegdoublesmassinitial mass in solar massessolMassfloatageAge of the starGyrfloatloggSurface gravity of starlog(cm/(s**2))floatphot_g_mean_magapparent G mag including extinctionmagfloatindexedphot_bp_mean_magapparent BP mag including extinctionmagfloatindexedphot_rp_mean_magapparent RP mag including extinctionmagfloatindexedphot_rvs_mean_magapparent RVS mag including extinctionmagfloatpopidPopulation ID according to the Besancon model. Including SMC/LMC = 10 and stellar clusters = 11shortmactactual (present) mass in solar massessolMassfloatphot_g_mean_mag_errorerror in Gmagfloata_gExtinction in Gmagfloata_bpExtinction in BPmagfloata_rpExtinction in RPmagfloata_rvsExtinction in RVSmagfloatparallaxparallax in masmasfloatindexedradial_velocityRadial velocity in km/skm/sfloatpm_raProper motion in projection of right ascensionmas/yrfloatpm_decProper motion in declinationmas/yrfloatparallax_errorparallax uncertainty in masmasfloatradial_velocity_errorRadial velocity uncertainty in km/skm/sfloatphot_g_n_obsNumber of photometric observations (trained from DR2 scaled to DR3 time)shortvisibility_periods_usedNumber of observations effectively used for the astrometric solutions (trained from DR2 scaled to DR3)shortsource_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table, .meta.id.crossintindexedrandom_indexRandom index that can be used to deterministically select subsetsintindexedd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshort
gedr3mock.mainA synthetic Milky Way catalog mimicking Gaia EDR3 in stellar content -and data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoublenullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoublenullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_mag[GeDR3mock only] apparent magnitude of the RVS band.magphot.color;em.opt.Ifloatnullablephot_g_mean_mag_error[GeDR3mock only] G mag error approximated by the symmetrised flux error.magphot.color;em.opt.Vfloatnullablephot_bp_mean_mag_error[GeDR3mock only] BP mag error (generated by scaling the G mag error with an empirical factor of 19.854 derived from GDR2).magphot.color;em.opt.Bfloatnullablephot_rp_mean_mag_error[GeDR3mock only] RP mag error (generated by scaling the G mag error with an empirical factor of 9.1205 derived from GDR2).magphot.color;em.opt.Rfloatnullablephot_rvs_mean_mag_error[GeDR3mock only] RVS mag error (generated by scaling the G mag error with with 30; this is essentially a wild guess which is probably too low if RVS magnitudes are provided at all).magphot.color;em.opt.Rfloatnullablerv_nb_transits[NULL] Number of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epoch[NULL] Reference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_q[NULL] Hipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noise[NULL] Excess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sig[NULL] Significance of excess noisestat.valuefloatnullableastrometric_n_obs_ac[NULL ]Total number of observations ACmeta.numbershortastrometric_n_obs_al[NULL] Total number of observations ALmeta.numbershortastrometric_n_bad_obs_ac[NULL] Number of bad observations ACmeta.numbershortastrometric_n_bad_obs_al[NULL] Number of bad observations ALmeta.numbershortastrometric_n_good_obs_ac[NULL] Number of good observations ACmeta.numbershortastrometric_n_good_obs_al[NULL] Number of good observations ALmeta.numbershortastrometric_chi2_al[NULL] Astrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flag[NULL] Only primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colour[NULL] Colour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_al[NULL] Mean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisibility_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_max[NULL] The longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observations[NULL] The number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_used[NULL] Type of prior used in in the astrometric solutionshortnullableastrometric_relegation_factor[NULL] Relegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_ac[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_al[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_source[NULL] During data processing, this source happened to have been duplicated and one source only has been kept.shortd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshortra_dec_corr[NULL] Correlation between right ascension and declinationstat.correlationfloatnullablera_pmra_corr[NULL] Correlation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corr[NULL] Correlation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corr[NULL] Correlation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corr[NULL] Correlation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corr[NULL] Correlation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corr[NULL] Correlation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corr[NULL] Correlation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corr[NULL] Correlation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corr[NULL] Correlation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4[NULL] Degree of concentration of scan directions across the sourcefloatnullablepriam_flags[NULL] Flags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flags[NULL] Flags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lower[Null] Lower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upper[Null] Upper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_bp_valEstimate of the line-of-sight extinction in the BP-band from Apsis-Priammagphys.absorptionfloatnullablea_bp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_bp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rp_valEstimate of the line-of-sight extinction in the RP-band from Apsis-Priammagphys.absorptionfloatnullablea_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rvs_valEstimate of the line-of-sight extinction in the RVS-band from Apsis-Priammagphys.absorptionfloatnullablea_rvs_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rvs_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lower[Null] Lower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upper[Null] Upper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lower[Null] Lower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upper[Null] Upper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefeh[GeDR3mock only] Fe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0[GeDR3mock only] Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullableinitial_mass[GeDR3mock only] Initial mass of the starsolMassphys.massfloatnullablecurrent_mass[GeDR3mock only] Current mass of the starsolMassphys.massfloatnullableage[GeDR3mock only] Age of the starGyrtime.agefloatnullablelogg[GeDR3mock only] Logarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablepopid[GeDR3mock only] Population ID according to the Besancon model. 10=SMC/LMC, 11=stellar clusterssrc.classshortpm_total[GeDR3mock only] Total proper motion of the star, i.e., sqrt(pmra^2+pmdec^2).mas/yrpos.pmfloatnullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table.meta.id.crossintindexedgedr3mock.parsec_propsindex_parsecindex_parsec
gedr3mock.maglim_5 +model.1600000000teffeffective TemperatureKfloatfehlog of metallicity in solar units ('dex')floata0monochramatic Extinction at lambda=547.7nmmagfloatlumStellar luminositysolLumfloatlGalactic longitudedegdoublebGalactic latitudedegdoublesmassinitial mass in solar massessolMassfloatageAge of the starGyrfloatloggSurface gravity of starlog(cm/(s**2))floatphot_g_mean_magapparent G mag including extinctionmagfloatindexedphot_bp_mean_magapparent BP mag including extinctionmagfloatindexedphot_rp_mean_magapparent RP mag including extinctionmagfloatindexedphot_rvs_mean_magapparent RVS mag including extinctionmagfloatpopidPopulation ID according to the Besancon model. Including SMC/LMC = 10 and stellar clusters = 11shortmactactual (present) mass in solar massessolMassfloatphot_g_mean_mag_errorerror in Gmagfloata_gExtinction in Gmagfloata_bpExtinction in BPmagfloata_rpExtinction in RPmagfloata_rvsExtinction in RVSmagfloatparallaxparallax in masmasfloatindexedradial_velocityRadial velocity in km/skm/sfloatpm_raProper motion in projection of right ascensionmas/yrfloatpm_decProper motion in declinationmas/yrfloatparallax_errorparallax uncertainty in masmasfloatradial_velocity_errorRadial velocity uncertainty in km/skm/sfloatphot_g_n_obsNumber of photometric observations (trained from DR2 scaled to DR3 time)shortvisibility_periods_usedNumber of observations effectively used for the astrometric solutions (trained from DR2 scaled to DR3)shortsource_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table, .meta.id.crossintindexedrandom_indexRandom index that can be used to deterministically select subsetsintindexedd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshort
gedr3mock.maglim_5 This table gives empirical magnitude limits for G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels of 5 (scale roughly ~2 degrees). For each band @@ -713,7 +704,23 @@ limits were created using the `gdr2_completeness package`_ and users are encouraged to create custom-made magnitude limits with specific conditions, e.g. RVS sample with good parallaxes. -.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness196608hpxLevel 7 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3spurA classifier for spurious astrometric solutions in Gaia EDR3 This table contains estimates of the "fidelity" of Gaia eDR3 +.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness196608hpxLevel 7 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablegedr3mock.mainA synthetic Milky Way catalog mimicking Gaia EDR3 in stellar content +and data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoublenullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoublenullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_mag[GeDR3mock only] apparent magnitude of the RVS band.magphot.color;em.opt.Ifloatnullablephot_g_mean_mag_error[GeDR3mock only] G mag error approximated by the symmetrised flux error.magphot.color;em.opt.Vfloatnullablephot_bp_mean_mag_error[GeDR3mock only] BP mag error (generated by scaling the G mag error with an empirical factor of 19.854 derived from GDR2).magphot.color;em.opt.Bfloatnullablephot_rp_mean_mag_error[GeDR3mock only] RP mag error (generated by scaling the G mag error with an empirical factor of 9.1205 derived from GDR2).magphot.color;em.opt.Rfloatnullablephot_rvs_mean_mag_error[GeDR3mock only] RVS mag error (generated by scaling the G mag error with with 30; this is essentially a wild guess which is probably too low if RVS magnitudes are provided at all).magphot.color;em.opt.Rfloatnullablerv_nb_transits[NULL] Number of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epoch[NULL] Reference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_q[NULL] Hipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noise[NULL] Excess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sig[NULL] Significance of excess noisestat.valuefloatnullableastrometric_n_obs_ac[NULL ]Total number of observations ACmeta.numbershortastrometric_n_obs_al[NULL] Total number of observations ALmeta.numbershortastrometric_n_bad_obs_ac[NULL] Number of bad observations ACmeta.numbershortastrometric_n_bad_obs_al[NULL] Number of bad observations ALmeta.numbershortastrometric_n_good_obs_ac[NULL] Number of good observations ACmeta.numbershortastrometric_n_good_obs_al[NULL] Number of good observations ALmeta.numbershortastrometric_chi2_al[NULL] Astrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flag[NULL] Only primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colour[NULL] Colour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_al[NULL] Mean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisibility_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_max[NULL] The longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observations[NULL] The number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_used[NULL] Type of prior used in in the astrometric solutionshortnullableastrometric_relegation_factor[NULL] Relegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_ac[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_al[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_source[NULL] During data processing, this source happened to have been duplicated and one source only has been kept.shortd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshortra_dec_corr[NULL] Correlation between right ascension and declinationstat.correlationfloatnullablera_pmra_corr[NULL] Correlation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corr[NULL] Correlation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corr[NULL] Correlation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corr[NULL] Correlation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corr[NULL] Correlation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corr[NULL] Correlation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corr[NULL] Correlation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corr[NULL] Correlation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corr[NULL] Correlation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4[NULL] Degree of concentration of scan directions across the sourcefloatnullablepriam_flags[NULL] Flags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flags[NULL] Flags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lower[Null] Lower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upper[Null] Upper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_bp_valEstimate of the line-of-sight extinction in the BP-band from Apsis-Priammagphys.absorptionfloatnullablea_bp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_bp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rp_valEstimate of the line-of-sight extinction in the RP-band from Apsis-Priammagphys.absorptionfloatnullablea_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rvs_valEstimate of the line-of-sight extinction in the RVS-band from Apsis-Priammagphys.absorptionfloatnullablea_rvs_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rvs_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lower[Null] Lower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upper[Null] Upper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lower[Null] Lower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upper[Null] Upper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefeh[GeDR3mock only] Fe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0[GeDR3mock only] Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullableinitial_mass[GeDR3mock only] Initial mass of the starsolMassphys.massfloatnullablecurrent_mass[GeDR3mock only] Current mass of the starsolMassphys.massfloatnullableage[GeDR3mock only] Age of the starGyrtime.agefloatnullablelogg[GeDR3mock only] Logarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablepopid[GeDR3mock only] Population ID according to the Besancon model. 10=SMC/LMC, 11=stellar clusterssrc.classshortpm_total[GeDR3mock only] Total proper motion of the star, i.e., sqrt(pmra^2+pmdec^2).mas/yrpos.pmfloatnullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table.meta.id.crossintindexedgedr3mock.parsec_propsindex_parsecindex_parsec
gedr3mock.parsec_propsParsec-based photometry and extinction for GeDR3 Mock This table is intended to augment the Gaia photometry of GeDR3 Mock +stars with other bands and extinctions (Sloan, Johnson and 2MASS). The +grid was generated by binning all isochrones in logg, teff, and feh +and taking the median values of all isochrone models that fall within +one bin. We also report the median values of some astrophysical +parameters so that one can check how far the actual star abundances +deviate from the bin's median. For the extinction we report the +extinction for the specific isochrone bin in a specific photometric +band for 6 different values of monochromatic extinction, A_0, i.e. +1,2,3,5,10,20 mag. + +Sometimes stars in GeDR3 Mock depart from the isochrone grid, because, +e.g., the feh value is outside of the grid or values have been +interpolated by Galaxia in the catalog generation from the Parsec +isochrones. Then the index_parsec is assigned to the nearest neighbour +in log_lum and log_teff.243238index_parsecThe primary key of the photometry table, useful for joining with index_parsec in gedr3mock.main. This has the format LLLTTTFFF indexing bins in log_lum, log_teff, feh in the parsec isochrones. To find the actual bin centers, see the log_lum, log_teff, and meh_ini columns.meta.refintindexedmeh_iniLog of initial model metalicity at the center of this bin.phys.abund.zfloatnullablelog_ageMedian log of model star age at the parsec bin.log(yr)time.agefloatnullablem_iniMedian of the initial (zero age) mass of all model stars in the parsec bin.solMassphys.massfloatnullablem_actMedian of the current (at log_age) mass of all model star in the parsec bin.solMassphys.massfloatnullablelog_lumMedian Log of luminosity of all model stars in the parsec bin.log(solLum)phys.luminosityfloatnullablelog_teffMedian Log of the effective temperature of all model stars in the parsec bin.log(K)phys.temperature.effectivefloatnullablelog_gravMedian Log of the surface gravity of all model stars in the parsec bin.log(m/s**2)phys.gravityfloatnullablegaia_gMedian absolute magnitude in the Gaia G band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablegaia_bpbrMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_bpftMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_rpMedian absolute magnitude in the Gaia RP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablegaia_rvsMedian absolute magnitude in the Gaia RVS band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_uMedian absolute magnitude in the Johnson U band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullableubv_bMedian absolute magnitude in the Johnson B band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullableubv_vMedian absolute magnitude in the Johnson V band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullableubv_rMedian absolute magnitude in the Johnson R band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_iMedian absolute magnitude in the Johnson I band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullableubv_jMedian absolute magnitude in the Johnson J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullableubv_hMedian absolute magnitude in the Johnson H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullableubv_kMedian absolute magnitude in the Johnson K band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullableubv_lMedian absolute magnitude in the Johnson L band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.3-4umfloatnullableubv_mMedian absolute magnitude in the Johnson M band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.4-8umfloatnullablesloan_uMedian absolute magnitude in the SDSS u band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullablesloan_gMedian absolute magnitude in the SDSS g band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablesloan_rMedian absolute magnitude in the SDSS r band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablesloan_iMedian absolute magnitude in the SDSS i band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullablesloan_zMedian absolute magnitude in the SDSS z band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullabletmass_jMedian absolute magnitude in the 2MASS J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullabletmass_hMedian absolute magnitude in the 2MASS H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullabletmass_ksMedian absolute magnitude in the 2MASS K' band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullablea0_1_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_1_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_1_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_2_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_2_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_2_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_3_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_3_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_3_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_5_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_5_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_5_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_10_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_10_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_10_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_20_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_20_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_20_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullable
gedr3spurA classifier for spurious astrometric solutions in Gaia EDR3 This table contains estimates of the "fidelity" of Gaia eDR3 astrometric solutions, a measure of the likelihood the eDR3 solution is physical rather than spurious obtained using a neural network trained on a small, hand-selected sample.gedr3spur.main This table contains estimates of the "fidelity" of Gaia eDR3 @@ -729,9 +736,9 @@ present here should be exposed through Registry records. However, in reality data providers currently are much more liable to give column metadata in their tap_schema than in their Registry records. Hence, for the time being, we maintain this service by harvesting -tap_schemas about monthly.
glots.servicesA table of TAP services harvested from the registry (and some +tap_schemas about monthly.
glots.columnsA table of columns within the tables listed in glots.tables.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columncharindexednullableunitUnit in VO standard formatcharnullableucdUCD of column (some services still have 1.0 UCDs).charindexednullableutypeUtype of columncharnullabledatatypeADQL datatypecharnullable"size"Length of variable length datatypesintnullableprincipalIs column principal?charnullableindexedIs there an index on this column?intnullablestdIs this a standard column?charnullableglots.tablesivoidivoidtable_nametable_name
glots.servicesA table of TAP services harvested from the registry (and some spoon-fed).ivoidIVOA identifier of providing servicecharindexedprimaryaccessurlBase URL of TAP endpointcharnullablenextharvestNext scheduled harvest of datacharnullableharvestintervalApproximate interval of harvestdintnullablelastsuccessLast successful harvest of this servicecharnullable
glots.tablesA table of tables accesible through the TAP services known to -glots.services.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarytable_descBrief description of the tableunicodeCharindexednullableutypeutype if the table corresponds to a data modelcharnullableglots.servicesivoidivoid
glots.columnsA table of columns within the tables listed in glots.tables.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columncharindexednullableunitUnit in VO standard formatcharnullableucdUCD of column (some services still have 1.0 UCDs).charindexednullableutypeUtype of columncharnullabledatatypeADQL datatypecharnullable"size"Length of variable length datatypesintnullableprincipalIs column principal?charnullableindexedIs there an index on this column?intnullablestdIs this a standard column?charnullableglots.tablesivoidivoidtable_nametable_name
gps1The Gaia-PS1-SDSS (GPS1) Proper Motion Catalog +glots.services.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarytable_descBrief description of the tableunicodeCharindexednullableutypeutype if the table corresponds to a data modelcharnullableglots.servicesivoidivoidgps1The Gaia-PS1-SDSS (GPS1) Proper Motion Catalog This catalog combines Gaia DR1, Pan-STARRS 1, SDSS and 2MASS astrometry to compute proper motions for 350 million sources across three-fourths of the sky down to a magnitude of mr≈20. Positions of galaxies from Pan-STARRS 1 @@ -838,8 +845,8 @@ intervening star field.inflight.data1200000lineDistance indicator in 0.01 Einstein radiipos.distanceintindexeddataBase64 encoded 8-bit image datacharnullablesrcnameName of file this line came frommeta.refcharnullablegauss01Magnification for a Gauss disk source with r=1magphot.mag;arith.difffloatnullablegauss02Magnification for a Gauss disk source with r=2magphot.mag;arith.difffloatnullablegauss04Magnification for a Gauss disk source with r=4magphot.mag;arith.difffloatnullablegauss06Magnification for a Gauss disk source with r=6magphot.mag;arith.difffloatnullablegauss08Magnification for a Gauss disk source with r=8magphot.mag;arith.difffloatnullablegauss10Magnification for a Gauss disk source with r=10magphot.mag;arith.difffloatnullablegauss12Magnification for a Gauss disk source with r=12magphot.mag;arith.difffloatnullablegauss16Magnification for a Gauss disk source with r=16magphot.mag;arith.difffloatnullablegauss20Magnification for a Gauss disk source with r=20magphot.mag;arith.difffloatnullablegauss24Magnification for a Gauss disk source with r=24magphot.mag;arith.difffloatnullablegauss28Magnification for a Gauss disk source with r=28magphot.mag;arith.difffloatnullablegauss32Magnification for a Gauss disk source with r=32magphot.mag;arith.difffloatnullablegauss40Magnification for a Gauss disk source with r=40magphot.mag;arith.difffloatnullablegauss48Magnification for a Gauss disk source with r=48magphot.mag;arith.difffloatnullablethin01Amplification of a thin disk of r=1magphot.mag;arith.diff;meta.mainfloatnullablethin02Magnification for thin disk with r=2magphot.mag;arith.difffloatnullablethin04Magnification for thin disk with r=4magphot.mag;arith.difffloatnullablethin06Magnification for thin disk with r=6magphot.mag;arith.difffloatnullablethin08Magnification for thin disk with r=8magphot.mag;arith.difffloatnullablethin10Magnification for thin disk with r=10magphot.mag;arith.difffloatnullablethin12Magnification for thin disk with r=12magphot.mag;arith.difffloatnullablethin16Magnification for thin disk with r=16magphot.mag;arith.difffloatnullablethin20Magnification for thin disk with r=20magphot.mag;arith.difffloatnullablethin24Magnification for thin disk with r=24magphot.mag;arith.difffloatnullablethin28Magnification for thin disk with r=28magphot.mag;arith.difffloatnullable
ivoaDefinition and support code for the ObsCore data model and table.ivoa.obs_radioAn IVOA-defined metadata table for radio measurements, with extra metadata for interferometric measurements ("visibilities") as well as single-dish observations. You will almost always want to join this -table to ivoa.obscore (do a natural join).ivo://ivoa.net/std/ObsRadio#table-1.0obs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexedprimarys_resolution_minAngular resolution, longest baseline and max frequency dependentarcsecpos.angResolution;stat.minChar.SpatialAxis.Resolution.Bounds.Limits.LoLimfloatnullables_resolution_maxAngular resolution, longest baseline and min frequency dependentarcsecpos.angResolution;stat.maxChar.SpatialAxis.Resolution.Bounds.Limits.HiLimfloatnullables_fov_minField of view diameter, min value, max frequency dependentdegphys.angSize;instr.fov;stat.minChar.SpatialAxis.Coverage.Bounds.Extent.LowLimfloatnullables_fov_maxField of view diameter, max value, min frequency dependentdegphys.angSize;instr.fov;stat.maxChar.SpatialAxis.Coverage.Bounds.Extent.HiLimfloatnullables_maximum_angular_scaleMaximum scale in dataset, shortest baseline and frequency dependentarcsecphys.angSize;stat.maxChar.SpatialAxis.Resolution.Scale.Limits.HiLimfloatnullablef_resolutionAbsolute spectral resolution in frequencykHzem.freq;stat.maxChar.SpectralAxis.Coverage.BoundsLimits.HiLimfloatnullablet_exp_minMinimum integration time per samplestime.duration;obs.exposure;stat.minChar.TimeAxis.Sampling.ExtentLoLimfloatnullablet_exp_maxMaximum integration time per samplestime.duration;obs.exposure;stat.maxChar.TimeAxis.Sampling.ExtentHiLimfloatnullablet_exp_meanAverage integration time per samplestime.duration;obs.exposure;stat.meanChar.TimeAxis.Sampling.ExtentHiLimfloatnullableuv_distance_minMinimal distance in uv planemstat.fourier;pos;stat.minChar.UVAxis.Coverage.Bounds.Limits.LoLimfloatnullableuv_distance_maxMaximal distance in uv planemstat.fourier;pos;stat.maxChar.UVAxis.Coverage.Bounds.Limits.LoLimfloatnullableuv_distribution_eccEccentricity of uv distributionstat.fourier;posChar.UVAxis.Coverage.Bounds.Eccentricityfloatnullableuv_distribution_fillFilling factor of uv distributionstat.fourier;pos;arith.ratioChar.UVAxis.Coverage.Bounds.FillingFactorfloatnullableinstrument_ant_numberNumber of antennas in arraymeta.number;instr.paramProvenance.ObsConfig.Instrument.Array.AntNumberfloatnullableinstrument_ant_min_distMinimum distance between antennas in arrayminstr.baseline;stat.minProvenance.ObsConfig.Instrument.Array.MinDistfloatnullableinstrument_ant_max_distMaximum distance between antennas in arrayminstr.baseline;stat.maxProvenance.ObsConfig.Instrument.Array.MaxDistfloatnullableinstrument_ant_diameterDiameter of telecope or antennas in arrayminstr.paramProvenance.ObsConfig.Instrument.Array.Diameterfloatnullableinstrument_feedNumber of feedsinstr.paramProvenance.ObsConfig.Instrument.Feedfloatnullablescan_modeScan mode (on-off, raster map, on-the-fly map,...)instr.paramProvenance.Observation.sky_scan_modefloatnullabletracking_modeTargeted, alt-azimuth, wobble, ...)instr.paramProvenance.Observation.tracking_modefloatnullableivoa.obscoreobs_publisher_didobs_publisher_did
ivoa.obscoreGAVO Data Center Obscore TableThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter.84947229dataproduct_typeHigh level scientific classification of the data product, taken from an enumerationmeta.code.classobscore:obsdataset.dataproducttypecharnullabledataproduct_subtypeData product specific typemeta.code.classobscore:obsdataset.dataproductsubtypecharnullablecalib_levelAmount of data processing that has been applied to the datameta.code;obs.calibobscore:obsdataset.caliblevelshortobs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_resolutionMinimal significant time interval along the time axisstime.resolutionobscore:char.timeaxis.resolution.refval.valuefloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablepol_statesList of polarization states in the data setmeta.code;phys.polarizationobscore:Char.PolarizationAxis.stateListcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullablet_xelNumber of elements (typically pixels) along the time axis.meta.numberobscore:Char.TimeAxis.numBinslongnullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullablepol_xelNumber of elements (typically pixels) along the polarization axis.meta.numberobscore:Char.PolarizationAxis.numBinslongnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullableem_ucdNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)meta.ucdobscore:Char.SpectralAxis.ucdcharnullablepreviewURL of a preview (low-resolution, quick-to-retrieve representation) of the data.meta.ref.url;meta.previewcharnullablesource_tableName of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.meta.id;meta.tablecharnullable
k2c9vstCoordinated microlensing survey observations with Kepler K2/C9 using +table to ivoa.obscore (do a natural join).</description><utype>ivo://ivoa.net/std/obsradio#table-1.0</utype><column><name>obs_publisher_did</name><description>Dataset identifier assigned by the publisher.</description><ucd>meta.ref.ivoid</ucd><utype>obscore:curation.publisherdid</utype><dataType arraysize="*" xsi:type="vs:VOTableType">char</dataType><flag>indexed</flag><flag>primary</flag></column><column><name>s_resolution_min</name><description>Angular resolution, longest baseline and max frequency dependent</description><unit>arcsec</unit><ucd>pos.angResolution;stat.min</ucd><utype>Char.SpatialAxis.Resolution.Bounds.Limits.LoLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>s_resolution_max</name><description>Angular resolution, longest baseline and min frequency dependent</description><unit>arcsec</unit><ucd>pos.angResolution;stat.max</ucd><utype>Char.SpatialAxis.Resolution.Bounds.Limits.HiLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>s_fov_min</name><description>Field of view diameter, min value, max frequency dependent</description><unit>deg</unit><ucd>phys.angSize;instr.fov;stat.min</ucd><utype>Char.SpatialAxis.Coverage.Bounds.Extent.LowLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>s_fov_max</name><description>Field of view diameter, max value, min frequency dependent</description><unit>deg</unit><ucd>phys.angSize;instr.fov;stat.max</ucd><utype>Char.SpatialAxis.Coverage.Bounds.Extent.HiLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>s_maximum_angular_scale</name><description>Maximum scale in dataset, shortest baseline and frequency dependent</description><unit>arcsec</unit><ucd>phys.angSize;stat.max</ucd><utype>Char.SpatialAxis.Resolution.Scale.Limits.HiLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>f_resolution</name><description>Absolute spectral resolution in frequency</description><unit>kHz</unit><ucd>em.freq;stat.max</ucd><utype>Char.SpectralAxis.Coverage.BoundsLimits.HiLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>t_exp_min</name><description>Minimum integration time per sample</description><unit>s</unit><ucd>time.duration;obs.exposure;stat.min</ucd><utype>Char.TimeAxis.Sampling.ExtentLoLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>t_exp_max</name><description>Maximum integration time per sample</description><unit>s</unit><ucd>time.duration;obs.exposure;stat.max</ucd><utype>Char.TimeAxis.Sampling.ExtentHiLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>t_exp_mean</name><description>Average integration time per sample</description><unit>s</unit><ucd>time.duration;obs.exposure;stat.mean</ucd><utype>Char.TimeAxis.Sampling.ExtentHiLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>uv_distance_min</name><description>Minimal distance in uv plane</description><unit>m</unit><ucd>stat.fourier;pos;stat.min</ucd><utype>Char.UVAxis.Coverage.Bounds.Limits.LoLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>uv_distance_max</name><description>Maximal distance in uv plane</description><unit>m</unit><ucd>stat.fourier;pos;stat.max</ucd><utype>Char.UVAxis.Coverage.Bounds.Limits.LoLim</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>uv_distribution_ecc</name><description>Eccentricity of uv distribution</description><ucd>stat.fourier;pos</ucd><utype>Char.UVAxis.Coverage.Bounds.Eccentricity</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>uv_distribution_fill</name><description>Filling factor of uv distribution</description><ucd>stat.fourier;pos;arith.ratio</ucd><utype>Char.UVAxis.Coverage.Bounds.FillingFactor</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>instrument_ant_number</name><description>Number of antennas in array</description><ucd>meta.number;instr.param</ucd><utype>Provenance.ObsConfig.Instrument.Array.AntNumber</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>instrument_ant_min_dist</name><description>Minimum distance between antennas in array</description><unit>m</unit><ucd>instr.baseline;stat.min</ucd><utype>Provenance.ObsConfig.Instrument.Array.MinDist</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>instrument_ant_max_dist</name><description>Maximum distance between antennas in array</description><unit>m</unit><ucd>instr.baseline;stat.max</ucd><utype>Provenance.ObsConfig.Instrument.Array.MaxDist</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>instrument_ant_diameter</name><description>Diameter of telecope or antennas in array</description><unit>m</unit><ucd>instr.param</ucd><utype>Provenance.ObsConfig.Instrument.Array.Diameter</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>instrument_feed</name><description>Number of feeds</description><ucd>instr.param</ucd><utype>Provenance.ObsConfig.Instrument.Feed</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>scan_mode</name><description>Scan mode (on-off, raster map, on-the-fly map,...)</description><ucd>instr.param</ucd><utype>Provenance.Observation.sky_scan_mode</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><column><name>tracking_mode</name><description>Targeted, alt-azimuth, wobble, ...)</description><ucd>instr.param</ucd><utype>Provenance.Observation.tracking_mode</utype><dataType xsi:type="vs:VOTableType">float</dataType><flag>nullable</flag></column><foreignKey><targetTable>ivoa.obscore</targetTable><fkColumn><fromColumn>obs_publisher_did</fromColumn><targetColumn>obs_publisher_did</targetColumn></fkColumn></foreignKey></table><table><name>ivoa.obscore</name><title>GAVO Data Center Obscore TableThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter.ivo://ivoa.net/std/obscore#table-1.184947229dataproduct_typeHigh level scientific classification of the data product, taken from an enumerationmeta.code.classobscore:obsdataset.dataproducttypecharnullabledataproduct_subtypeData product specific typemeta.code.classobscore:obsdataset.dataproductsubtypecharnullablecalib_levelAmount of data processing that has been applied to the datameta.code;obs.calibobscore:obsdataset.caliblevelshortobs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_resolutionMinimal significant time interval along the time axisstime.resolutionobscore:char.timeaxis.resolution.refval.valuefloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablepol_statesList of polarization states in the data setmeta.code;phys.polarizationobscore:Char.PolarizationAxis.stateListcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullablet_xelNumber of elements (typically pixels) along the time axis.meta.numberobscore:Char.TimeAxis.numBinslongnullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullablepol_xelNumber of elements (typically pixels) along the polarization axis.meta.numberobscore:Char.PolarizationAxis.numBinslongnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullableem_ucdNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)meta.ucdobscore:Char.SpectralAxis.ucdcharnullablepreviewURL of a preview (low-resolution, quick-to-retrieve representation) of the data.meta.ref.url;meta.previewcharnullablesource_tableName of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.meta.id;meta.tablecharnullablek2c9vstCoordinated microlensing survey observations with Kepler K2/C9 using VST The Kepler satellite has observed the Galactic center in a campaign lasting from April until the end of June 2016 (K2/C9). The main objective of the 99 hours for the microlensing program 097.C-0261(A) @@ -946,11 +953,11 @@ Telescope (or Guoshoujing Telescope) is an instrument tailored for producing large number of optical medium- and low-resolution spectra. Here, we publish both the medium (MRS) and low (LRS) resolution spectra from Data Release 6, http://dr6.lamost.org/v2/, to the Virtual -Observatory.lamost6.ssa_mrsSSA-compliant metadata for LAMOST DR6 medium resolution spectra; this +Observatory.
lamost6.ssa_lrsSSA-compliant metadata for LAMOST DR6 low resolution spectra; this data is also availble through Obscore; the collection name there is -LAMOST6 MRS.5900000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.ResolutionfloatnullablemobsidUnique identifier for the medium resolution spectrum (most of these have multiple observations and include a coadded spectrum).meta.id;meta.maincharssa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablerv_b0Radial velocity estimated from the B spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_b0_errError in rv_b0.km/sstat.error;spect.dopplerVelocfloatnullablerv_r0Radial velocity estimated from the R spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_r0_errError in rv_r0.km/sstat.error;spect.dopplerVelocfloatnullablerv_br0Radial velocity estimated from the B and R spectra after continuum removal.km/sspect.dopplerVelocfloatnullablerv_br0_errError in rv_br0.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp0Radial velocity estimated from the LAMOST stellar parameter pipeline.km/sspect.dopplerVelocfloatnullablerv_lasp0_errError in rv_lasp0.km/sstat.error;spect.dopplerVelocfloatnullablerv_b1rv_b0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_b1_errError in rv_b1.km/sstat.error;spect.dopplerVelocfloatnullablerv_r1rv_r0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_r1_errError in rv_r1.km/sstat.error;spect.dopplerVelocfloatnullablerv_br1rv_br0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_br1_errError in rv_br1.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp1rv_lasp0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_lasp1_errError in rv_lasp1.km/sstat.error;spect.dopplerVelocfloatnullablerv_b_flagFlag for RV extraction in the b band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_r_flagFlag for RV extraction in the r band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_br_flagFlag for RV extraction in the br band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortcoadd1 if this is a co-added spectrummeta.codeshortfibermaskBitmask for fiber problems. See note for the meaning for the bits.meta.code.qualshortbad_b1 if this is a problematic B spectrum.meta.codeshortbad_r1 if this is a problematic R spectrum.meta.codeshort
lamost6.ssa_lrsSSA-compliant metadata for LAMOST DR6 low resolution spectra; this +LAMOST6 LRS.10000000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift as estimated by the LAMOST pipeline.src.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablez_errError in ssa_redshift as estimated by the LAMOST pipeline.stat.error;src.redshiftfloatnullable
lamost6.ssa_mrsSSA-compliant metadata for LAMOST DR6 medium resolution spectra; this data is also availble through Obscore; the collection name there is -LAMOST6 LRS.10000000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift as estimated by the LAMOST pipeline.src.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablez_errError in ssa_redshift as estimated by the LAMOST pipeline.stat.error;src.redshiftfloatnullable
life_tdThe LIFE Target Star Database LIFETD +LAMOST6 MRS.5900000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.ResolutionfloatnullablemobsidUnique identifier for the medium resolution spectrum (most of these have multiple observations and include a coadded spectrum).meta.id;meta.maincharssa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablerv_b0Radial velocity estimated from the B spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_b0_errError in rv_b0.km/sstat.error;spect.dopplerVelocfloatnullablerv_r0Radial velocity estimated from the R spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_r0_errError in rv_r0.km/sstat.error;spect.dopplerVelocfloatnullablerv_br0Radial velocity estimated from the B and R spectra after continuum removal.km/sspect.dopplerVelocfloatnullablerv_br0_errError in rv_br0.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp0Radial velocity estimated from the LAMOST stellar parameter pipeline.km/sspect.dopplerVelocfloatnullablerv_lasp0_errError in rv_lasp0.km/sstat.error;spect.dopplerVelocfloatnullablerv_b1rv_b0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_b1_errError in rv_b1.km/sstat.error;spect.dopplerVelocfloatnullablerv_r1rv_r0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_r1_errError in rv_r1.km/sstat.error;spect.dopplerVelocfloatnullablerv_br1rv_br0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_br1_errError in rv_br1.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp1rv_lasp0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_lasp1_errError in rv_lasp1.km/sstat.error;spect.dopplerVelocfloatnullablerv_b_flagFlag for RV extraction in the b band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_r_flagFlag for RV extraction in the r band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_br_flagFlag for RV extraction in the br band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortcoadd1 if this is a co-added spectrummeta.codeshortfibermaskBitmask for fiber problems. See note for the meaning for the bits.meta.code.qualshortbad_b1 if this is a problematic B spectrum.meta.codeshortbad_r1 if this is a problematic R spectrum.meta.codeshortlife_tdThe LIFE Target Star Database LIFETD The LIFE Target Star Database contains information useful for the planned `LIFE mission`_ (mid-ir, nulling interferometer in space). It characterizes possible @@ -963,78 +970,78 @@ data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -.. _LIFE mission: https://life-space-mission.com/life_td.sourceSource Table A list of all the sources for the parameters in the other tables. +.. _LIFE mission: https://life-space-mission.com/
life_td.disk_basicBasic disk parameters A list of all basic disk parameters. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -281source_idSource identifier.meta.idintindexedprimaryrefReference, bibcode if possible.meta.refcharnullableprovider_nameName for the service through which the data was acquired. SIMBAD: service = http://simbad.u-strasbg.fr:80/simbad/sim-tap, bibcode = 2000A&AS..143....9W. ExoMercat: service = http://archives.ia2.inaf.it/vo/tap/projects, bibcode = 2020A&C....3100370A. Everything else is acquired through private communication.meta.bib.authorchar
life_td.objectObject table A list of the astrophysical objects. +33object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryrad_valueBlack body radius.AUphys.size.radiusdoublenullablerad_errRadius errorAUstat.error;phys.size.radiusdoublenullablerad_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullablerad_relRadius relation defining upper / lower limit or exact measurement through '<' ,'>', and '='.phys.size.radius;arith.ratiocharnullablerad_source_idrefIdentifier of the source of the disk parameters.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.h_linkObject relation table This table links subordinate objects (e.g. a planets of a star, or a +star in a multiple star system) to their parent objects. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -3672object_idObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarytypeObject type (sy=multi-object system, st=star, pl=planet and di=disk).src.classcharnullablemain_idMain object identifier.meta.idcharidsAll identifiers of the object separated by '|'.meta.idchar
life_td.providerProvider Table A list of all the providers for the parameters in the other tables. +846parent_object_idrefObject key (unstable, use only for joining to the other tables).meta.id.parent;meta.mainintindexedprimarychild_object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimarymembershipMembership probability.meta.recordintnullableh_link_source_idrefIdentifier of the source of the relationship parameters.meta.refintindexedprimary
life_td.identObject identifiers table A list of the object identifiers. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -provider_nameName for the service through which the data was acquired.meta.bib.authorcharindexedprimaryprovider_urlService through which the data was acquired.meta.ref.urlcharnullableprovider_bibcodeReference, bibcode if possible.meta.refcharnullableprovider_accessDate of access to provider.timecharnullable
life_td.star_basicBasic stellar parameters A list of all basic stellar parameters. +63295object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimaryidObject identifier.meta.idcharindexedprimaryid_source_idrefIdentifier of the source of the identifier parameter.meta.refintindexedprimary
life_td.mes_binaryMultiplicitz measurement table A list of the stellar multiplicitz measurements. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -3137object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarycoo_raRight Ascensiondegpos.eq.ra;meta.maindoubleindexednullablecoo_decDeclinationdegpos.eq.dec;meta.maindoubleindexednullablecoo_err_angleCoordinate error angledegpos.posAng;pos.errorEllipse;pos.eqshortnullablecoo_err_majCoordinate error major axismasphys.angSize.smajAxis;pos.errorEllipse;pos.eqfloatnullablecoo_err_minCoordinate error minor axismasphys.angSize.sminAxis;pos.errorEllipse;pos.eqfloatnullablecoo_qualCoordinate quality (A:best, E:worst)meta.code.qual;pos.eqcharnullablecoo_source_idrefSource identifier corresponding to the position (coo) parameters.meta.refintnullablecoo_gal_lGalactical longitude.degpos.galactic.londoublenullablecoo_gal_bGalactical latitude.degpos.galactic.latdoublenullablecoo_gal_source_idrefSource identifier corresponding to the position (coo_gal) parameters.meta.refintnullablemag_i_valueMagnitude in I filter.phot.mag;em.opt.Idoublenullablemag_i_source_idrefSource identifier corresponding to the Magnitude in I filter parameters.meta.refintnullablemag_j_valueMagnitude in J filter.phot.mag;em.IR.Jdoublenullablemag_j_source_idrefSource identifier corresponding to the Magnitude in J filter parameters.meta.refintnullablemag_k_valueMagnitude in K filter.phot.mag;em.IR.Kdoublenullablemag_k_source_idrefSource identifier corresponding to the Magnitude in K filter parameters.meta.refintnullableplx_valueParallax value.maspos.parallaxdoublenullableplx_errParallax uncertainty.masstat.error;pos.parallaxdoublenullableplx_qualParallax quality (A:best, E:worst)meta.code.qual;pos.parallaxcharnullableplx_source_idrefSource identifier corresponding to the parallax parameters.meta.refintnullabledist_st_valueObject distance.pcpos.distancedoublenullabledist_st_errObject distance error.pcstat.error;pos.distancedoublenullabledist_st_qualDistance quality (A:best, E:worst)meta.code.qual;pos.distancecharnullabledist_st_source_idrefIdentifier of the source of the distance parameter.meta.refintnullablesptype_stringObject spectral type MK.src.spTypecharnullablesptype_errObject spectral type MK error.stat.error;src.spTypedoublenullablesptype_qualSpectral type MK quality (A:best, E:worst)meta.code.qual;src.spTypecharnullablesptype_source_idrefIdentifier of the source of the spectral type MK parameter.meta.ref;src.spTypeintnullableclass_tempObject spectral type MK temperature class.src.spTypecharnullableclass_temp_nrObject spectral type MK temperature class number.src.spTypecharnullableclass_lumObject spectral type MK luminosity class.src.spTypecharnullableclass_source_idrefIdentifier of the source of the spectral type MK classification parameter.meta.ref;src.spTypeintnullableteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintnullableradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintnullablemass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintnullablebinary_flagBinary flag.meta.code.multipcharnullablebinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintnullablesep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
life_td.planet_basicBasic planetary parameters A list of all basic planetary parameters. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarybinary_flagBinary flag.meta.code.multipcharindexedprimarybinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_mass_plMass measurement table A list of the planetary mass measurements. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -502object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.disk_basicBasic disk parameters A list of all basic disk parameters. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_mass_stMass measurement table A list of the stellar mass measurements. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -33object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryrad_valueBlack body radius.AUphys.size.radiusdoublenullablerad_errRadius errorAUstat.error;phys.size.radiusdoublenullablerad_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullablerad_relRadius relation defining upper / lower limit or exact measurement through '<' ,'>', and '='.phys.size.radius;arith.ratiocharnullablerad_source_idrefIdentifier of the source of the disk parameters.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.h_linkObject relation table This table links subordinate objects (e.g. a planets of a star, or a -star in a multiple star system) to their parent objects. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_radius_stRadius measurement table A list of the stellar radius measurements. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -846parent_object_idrefObject key (unstable, use only for joining to the other tables).meta.id.parent;meta.mainintindexedprimarychild_object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimarymembershipMembership probability.meta.recordintnullableh_link_source_idrefIdentifier of the source of the relationship parameters.meta.refintindexedprimary
life_td.identObject identifiers table A list of the object identifiers. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_sep_angPhys. separation measurement table A list of the stellar phys. separation measurements. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -63295object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimaryidObject identifier.meta.idcharindexedprimaryid_source_idrefIdentifier of the source of the identifier parameter.meta.refintindexedprimary
life_td.mes_mass_plMass measurement table A list of the planetary mass measurements. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintsep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
life_td.mes_teff_stEffective temperature measurement table A list of the stellar effective temperature measurements. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_teff_stEffective temperature measurement table A list of the stellar effective temperature measurements. +object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintindexedprimarylife_td.objectobject_idrefobject_id
life_td.objectObject table A list of the astrophysical objects. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_radius_stRadius measurement table A list of the stellar radius measurements. +3672object_idObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarytypeObject type (sy=multi-object system, st=star, pl=planet and di=disk).src.classcharnullablemain_idMain object identifier.meta.idcharidsAll identifiers of the object separated by '|'.meta.idchar
life_td.planet_basicBasic planetary parameters A list of all basic planetary parameters. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_mass_stMass measurement table A list of the stellar mass measurements. +502object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.providerProvider Table A list of all the providers for the parameters in the other tables. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_binaryMultiplicitz measurement table A list of the stellar multiplicitz measurements. +provider_nameName for the service through which the data was acquired.meta.bib.authorcharindexedprimaryprovider_urlService through which the data was acquired.meta.ref.urlcharnullableprovider_bibcodeReference, bibcode if possible.meta.refcharnullableprovider_accessDate of access to provider.timecharnullable
life_td.sourceSource Table A list of all the sources for the parameters in the other tables. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarybinary_flagBinary flag.meta.code.multipcharindexedprimarybinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_sep_angPhys. separation measurement table A list of the stellar phys. separation measurements. +281source_idSource identifier.meta.idintindexedprimaryrefReference, bibcode if possible.meta.refcharnullableprovider_nameName for the service through which the data was acquired. SIMBAD: service = http://simbad.u-strasbg.fr:80/simbad/sim-tap, bibcode = 2000A&AS..143....9W. ExoMercat: service = http://archives.ia2.inaf.it/vo/tap/projects, bibcode = 2020A&C....3100370A. Everything else is acquired through private communication.meta.bib.authorchar
life_td.star_basicBasic stellar parameters A list of all basic stellar parameters. Note that LIFE's target database is living data. The content – and to some extent even structure – of these tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintsep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
lightmeterLightmeter Data We give continuous night and day light measurements at all natural +3137object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarycoo_raRight Ascensiondegpos.eq.ra;meta.maindoubleindexednullablecoo_decDeclinationdegpos.eq.dec;meta.maindoubleindexednullablecoo_err_angleCoordinate error angledegpos.posAng;pos.errorEllipse;pos.eqshortnullablecoo_err_majCoordinate error major axismasphys.angSize.smajAxis;pos.errorEllipse;pos.eqfloatnullablecoo_err_minCoordinate error minor axismasphys.angSize.sminAxis;pos.errorEllipse;pos.eqfloatnullablecoo_qualCoordinate quality (A:best, E:worst)meta.code.qual;pos.eqcharnullablecoo_source_idrefSource identifier corresponding to the position (coo) parameters.meta.refintnullablecoo_gal_lGalactical longitude.degpos.galactic.londoublenullablecoo_gal_bGalactical latitude.degpos.galactic.latdoublenullablecoo_gal_source_idrefSource identifier corresponding to the position (coo_gal) parameters.meta.refintnullablemag_i_valueMagnitude in I filter.phot.mag;em.opt.Idoublenullablemag_i_source_idrefSource identifier corresponding to the Magnitude in I filter parameters.meta.refintnullablemag_j_valueMagnitude in J filter.phot.mag;em.IR.Jdoublenullablemag_j_source_idrefSource identifier corresponding to the Magnitude in J filter parameters.meta.refintnullablemag_k_valueMagnitude in K filter.phot.mag;em.IR.Kdoublenullablemag_k_source_idrefSource identifier corresponding to the Magnitude in K filter parameters.meta.refintnullableplx_valueParallax value.maspos.parallaxdoublenullableplx_errParallax uncertainty.masstat.error;pos.parallaxdoublenullableplx_qualParallax quality (A:best, E:worst)meta.code.qual;pos.parallaxcharnullableplx_source_idrefSource identifier corresponding to the parallax parameters.meta.refintnullabledist_st_valueObject distance.pcpos.distancedoublenullabledist_st_errObject distance error.pcstat.error;pos.distancedoublenullabledist_st_qualDistance quality (A:best, E:worst)meta.code.qual;pos.distancecharnullabledist_st_source_idrefIdentifier of the source of the distance parameter.meta.refintnullablesptype_stringObject spectral type MK.src.spTypecharnullablesptype_errObject spectral type MK error.stat.error;src.spTypedoublenullablesptype_qualSpectral type MK quality (A:best, E:worst)meta.code.qual;src.spTypecharnullablesptype_source_idrefIdentifier of the source of the spectral type MK parameter.meta.ref;src.spTypeintnullableclass_tempObject spectral type MK temperature class.src.spTypecharnullableclass_temp_nrObject spectral type MK temperature class number.src.spTypecharnullableclass_lumObject spectral type MK luminosity class.src.spTypecharnullableclass_source_idrefIdentifier of the source of the spectral type MK classification parameter.meta.ref;src.spTypeintnullableteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintnullableradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintnullablemass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintnullablebinary_flagBinary flag.meta.code.multipcharnullablebinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintnullablesep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_idlightmeterLightmeter Data We give continuous night and day light measurements at all natural outdoor light levels by a network of low-cost lightmeters. Developed to start simple, global continuous high cadence monitoring of night sky brightness and artificial night sky brightening (light pollution) @@ -1043,7 +1050,7 @@ Landessternwarte, Tautenburg, Germany and the Kuffner-Sternwarte society at the Kuffner-Observatory, Vienna, Austria. It started as part of the Dark Skies Awareness cornerstone of the -International Year of Astronomy.lightmeter.stationsStations in the lightmeter network44stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedprimarylatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullableheightHeight above sea levelmpos.earth.altitudefloatnullablefullnameFull name of the stationmeta.idchardevtypeDevice type (as in: IYA Lightmeter, SQM, ...)meta.code;instrcharnullabletimecorrectionSeconds to add to this stations reported times to obtain UTCintnullablecalibaCalibration parameter, ainstr.calibfloatnullablecalibbCalibration parameter, binstr.calibfloatnullablecalibcCalibration parameter, cW.m**-2instr.calibfloatnullablecalibdCalibration parameter, dK**-1instr.calibfloatnullable
lightmeter.measurementsTime-averaged lightmeter measurements3400000stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedepochJD of measurement, UTCdtime.epochdoubleindexedfluxCalibrated fluxW.m**-2phot.fluxfloats_fluxStandard deviation of light measurements contributing to this averageW.m**-2stat.stdev;phot.fluxfloatnullablenvalsNumber of measurements contributing to this valuemeta.number;obsintsourceSource file keymeta.id;meta.filecharnullable
lightmeter.geocountsLightmeter data by date and geographic positionepochJD of measurement, UTCdtime.epochdoublestationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharlatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullablefluxCalibrated fluxW.m**-2phot.fluxfloat
liverpoolLiverpool Quasar Lens MonitoringThis collection includes optical monitorings of gravitationally lensed +International Year of Astronomy.lightmeter.geocountsLightmeter data by date and geographic positionepochJD of measurement, UTCdtime.epochdoublestationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharlatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullablefluxCalibrated fluxW.m**-2phot.fluxfloat
lightmeter.measurementsTime-averaged lightmeter measurements3400000stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedepochJD of measurement, UTCdtime.epochdoubleindexedfluxCalibrated fluxW.m**-2phot.fluxfloats_fluxStandard deviation of light measurements contributing to this averageW.m**-2stat.stdev;phot.fluxfloatnullablenvalsNumber of measurements contributing to this valuemeta.number;obsintsourceSource file keymeta.id;meta.filecharnullable
lightmeter.stationsStations in the lightmeter network44stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedprimarylatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullableheightHeight above sea levelmpos.earth.altitudefloatnullablefullnameFull name of the stationmeta.idchardevtypeDevice type (as in: IYA Lightmeter, SQM, ...)meta.code;instrcharnullabletimecorrectionSeconds to add to this stations reported times to obtain UTCintnullablecalibaCalibration parameter, ainstr.calibfloatnullablecalibbCalibration parameter, binstr.calibfloatnullablecalibcCalibration parameter, cW.m**-2instr.calibfloatnullablecalibdCalibration parameter, dK**-1instr.calibfloatnullable
liverpoolLiverpool Quasar Lens MonitoringThis collection includes optical monitorings of gravitationally lensed quasars. The frames can be used to make light curves of quasar images and field objects. From quasar light curves, one may measure time delays and flux ratios, analyse variability and chromaticity, etc. @@ -1128,7 +1135,7 @@ quasars and the lensing galaxies. The spectra are resolved to about a few Ångstroms and are flux-calibrated. The spectra resulted from deblending the lensed images in bidimensional spectra available from the SSAP service for `ivo://org.gavo.dc/mlqso/q/s -<http://dc.zah.uni-heidelberg.de/mlqso/q/s/info>`_.mlqso.slitspectra Bidimensional spectra of galaxies lensing QSOs.832accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.LengthintnullableremarkRemarks on the data set by the data creator.meta.notecharnullable
mlqso.cubes Bidirectional spectra as FITS image.12accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullabledatalinkDatalinks (related data, cutouts, etc) for this datasetmeta.ref.urlcharnullable
mpcMinor Planet Center - Asteroid Orbital Data +<http://dc.zah.uni-heidelberg.de/mlqso/q/s/info>`_.mlqso.cubes Bidirectional spectra as FITS image.12accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullabledatalinkDatalinks (related data, cutouts, etc) for this datasetmeta.ref.urlcharnullable
mlqso.slitspectra Bidimensional spectra of galaxies lensing QSOs.832accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.LengthintnullableremarkRemarks on the data set by the data creator.meta.notecharnullable
mpcMinor Planet Center - Asteroid Orbital Data Complete Asteroid Data from the Minor Planet Center (MPC), updated once per month. The MPC operates at the Smithsonian Astrophysical Observatory under the auspices of Division III of the International @@ -1137,7 +1144,14 @@ Astronomical Union (IAU). The MPC Orbit database contains orbital elements of minor planets that have been published in the Minor Planet Circulars, the Minor Planet Orbit Supplement and the Minor Planet -Electronic Circulars.mpc.mpcorb +Electronic Circulars.
mpc.epn_core EPN-TAP table for MPC Asteroid Orbital Data The EPN-TAP 2.0 version of the complete asteroid data from the Minor +Planet Center (MPC), updated once per month. The MPC operates at the +Smithsonian Astrophysical Observatory under the auspices of Division +III of the International Astronomical Union (IAU). + +The MPC Orbit database contains orbital elements of minor planets that +have been published in the Minor Planet Circulars, the Minor Planet +Orbit Supplement and the Minor Planet Electronic Circulars.ivo://ivoa.net/std/epntap#table-2.0granule_uidInternal table row index, which must be unique within the table. Can be alphanumeric.meta.idchargranule_gidCommon to granules of same type (e.g. same map projection, or geometry data products). Can be alphanumeric.meta.idcharobs_idAssociates granules derived from the same data (e.g. various representations/processing levels). Can be alphanumeric, may be the ID of original observation.meta.id;obschardataproduct_typeThe high-level organization of the data product, from a controlled vocabulary (e.g., 'im' for image, sp for spectrum). Multiple terms may be used, separated by # characters.meta.code.classcharnullabletarget_nameStandard IAU name of target (from a list related to target class), case sensitivemeta.id;srcunicodeCharnullabletarget_classType of target, from a controlled vocabulary.src.classcharnullabletime_minAcquisition start time (in JD), as UTC at time_refpositiondtime.start;obsdoublenullabletime_maxAcquisition stop time (in JD), as UTC at time_refpositiondtime.end;obsdoublenullabletime_sampling_step_minSampling time for measurements of dynamical phenomena, lower limit.stime.resolution;stat.mindoublenullabletime_sampling_step_maxSampling time for measurements of dynamical phenomena, upper limitstime.resolution;stat.maxdoublenullabletime_exp_minIntegration time of the measurement, lower limit.stime.duration;obs.exposure;stat.mindoublenullabletime_exp_maxIntegration time of the measurement, upper limitstime.duration;obs.exposure;stat.maxdoublenullablespectral_range_minSpectral range (frequency), lower limit.Hzem.freq;stat.mindoublenullablespectral_range_maxSpectral range (frequency), upper limitHzem.freq;stat.maxdoublenullablespectral_sampling_step_minSpectral sampling step, lower limit.Hzem.freq;spect.binSize;stat.mindoublenullablespectral_sampling_step_maxSpectral sampling step, upper limitHzem.freq;spect.binSize;stat.maxdoublenullablespectral_resolution_minSpectral resolution, lower limit.spect.resolution;stat.mindoublenullablespectral_resolution_maxSpectral resolution, upper limitspect.resolution;stat.maxdoublenullablec1minRight Ascension (ICRS), lower limit.degpos.eq.ra;stat.mindoublenullablec1maxRight Ascension (ICRS), upper limitdegpos.eq.ra;stat.maxdoublenullablec2minDeclination (ICRS), lower limit.degpos.eq.dec;stat.mindoublenullablec2maxDeclination (ICRS), upper limitdegpos.eq.dec;stat.maxdoublenullablec3minDistance from coordinate origin, lower limit.AUpos.distance;stat.mindoublenullablec3maxDistance from coordinate origin, upper limitAUpos.distance;stat.maxdoublenullables_regionObsCore-like footprint, valid for celestial, spherical, or body-fixed framespos.outline;obs.fieldcharnullablec1_resol_minResolution in the first coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec1_resol_maxResolution in the first coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec2_resol_minResolution in the second coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec2_resol_maxResolution in the second coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec3_resol_minResolution in the third coordinate, lower limit.AUpos.resolution;stat.mindoublenullablec3_resol_maxResolution in the third coordinate, upper limitAUpos.resolution;stat.maxdoublenullablespatial_frame_typeFlavor of coordinate system, defines the nature of coordinates. From a controlled vocabulary, where 'none' means undefined.meta.code.class;pos.framecharnullableincidence_minIncidence angle (solar zenithal angle) during data acquisition, lower limit.degpos.incidenceAng;stat.mindoublenullableincidence_maxIncidence angle (solar zenithal angle) during data acquisition, upper limitdegpos.incidenceAng;stat.maxdoublenullableemergence_minEmergence angle during data acquisition, lower limit.degpos.emergenceAng;stat.mindoublenullableemergence_maxEmergence angle during data acquisition, upper limitdegpos.emergenceAng;stat.maxdoublenullablephase_minPhase angle during data acquisition, lower limit.degpos.phaseAng;stat.mindoublenullablephase_maxPhase angle during data acquisition, upper limitdegpos.phaseAng;stat.maxdoublenullableinstrument_host_nameStandard name of the observatory or spacecraftmeta.id;instr.obstycharnullableinstrument_nameStandard name of instrumentmeta.id;instrcharnullablemeasurement_typeUCD(s) defining the data, with multiple entries separated by hash (#) characters.meta.ucdcharnullableprocessing_levelDataset-related encoding, or simplified CODMAC calibration levelmeta.calibLevelintcreation_dateDate of first entry of this granuletime.creationcharnullablemodification_dateDate of last modification (used to handle mirroring)time.processingcharnullablerelease_dateStart of public access periodtime.releasecharnullableservice_titleTitle of resource (an acronym really, will be used to handle multiservice results)meta.titlecharnullablealt_target_nameProvides alternative target name if more common (e.g. comets); multiple identifiers can be separated by hashesmeta.id;srcunicodeCharnullablemagnitudeAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatnullableslope_parameterSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemi_major_axisOrbital semimajor axisAUphys.size.smajAxisfloatnullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mpc.mpcorb Complete Asteroid Data from the Minor Planet Center (MPC), updated once per month. The MPC operates at the Smithsonian Astrophysical Observatory under the auspices of Division III of the International @@ -1146,14 +1160,7 @@ Astronomical Union (IAU). The MPC Orbit database contains orbital elements of minor planets that have been published in the Minor Planet Circulars, the Minor Planet Orbit Supplement and the Minor Planet -Electronic Circulars.1200000designationAsteroid number or provisional designation.meta.id;meta.maincharnullablemagAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatindexednullableslopeSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemimaj_axOrbital semimajor axisAUphys.size.smajAxisfloatindexednullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablenameHuman-readable designation of the Asteroid.meta.idunicodeCharindexednullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mpc.epn_core EPN-TAP table for MPC Asteroid Orbital Data The EPN-TAP 2.0 version of the complete asteroid data from the Minor -Planet Center (MPC), updated once per month. The MPC operates at the -Smithsonian Astrophysical Observatory under the auspices of Division -III of the International Astronomical Union (IAU). - -The MPC Orbit database contains orbital elements of minor planets that -have been published in the Minor Planet Circulars, the Minor Planet -Orbit Supplement and the Minor Planet Electronic Circulars.ivo://ivoa.net/std/epntap#table-2.0granule_uidInternal table row index, which must be unique within the table. Can be alphanumeric.meta.idchargranule_gidCommon to granules of same type (e.g. same map projection, or geometry data products). Can be alphanumeric.meta.idcharobs_idAssociates granules derived from the same data (e.g. various representations/processing levels). Can be alphanumeric, may be the ID of original observation.meta.id;obschardataproduct_typeThe high-level organization of the data product, from a controlled vocabulary (e.g., 'im' for image, sp for spectrum). Multiple terms may be used, separated by # characters.meta.code.classcharnullabletarget_nameStandard IAU name of target (from a list related to target class), case sensitivemeta.id;srcunicodeCharnullabletarget_classType of target, from a controlled vocabulary.src.classcharnullabletime_minAcquisition start time (in JD), as UTC at time_refpositiondtime.start;obsdoublenullabletime_maxAcquisition stop time (in JD), as UTC at time_refpositiondtime.end;obsdoublenullabletime_sampling_step_minSampling time for measurements of dynamical phenomena, lower limit.stime.resolution;stat.mindoublenullabletime_sampling_step_maxSampling time for measurements of dynamical phenomena, upper limitstime.resolution;stat.maxdoublenullabletime_exp_minIntegration time of the measurement, lower limit.stime.duration;obs.exposure;stat.mindoublenullabletime_exp_maxIntegration time of the measurement, upper limitstime.duration;obs.exposure;stat.maxdoublenullablespectral_range_minSpectral range (frequency), lower limit.Hzem.freq;stat.mindoublenullablespectral_range_maxSpectral range (frequency), upper limitHzem.freq;stat.maxdoublenullablespectral_sampling_step_minSpectral sampling step, lower limit.Hzem.freq;spect.binSize;stat.mindoublenullablespectral_sampling_step_maxSpectral sampling step, upper limitHzem.freq;spect.binSize;stat.maxdoublenullablespectral_resolution_minSpectral resolution, lower limit.spect.resolution;stat.mindoublenullablespectral_resolution_maxSpectral resolution, upper limitspect.resolution;stat.maxdoublenullablec1minRight Ascension (ICRS), lower limit.degpos.eq.ra;stat.mindoublenullablec1maxRight Ascension (ICRS), upper limitdegpos.eq.ra;stat.maxdoublenullablec2minDeclination (ICRS), lower limit.degpos.eq.dec;stat.mindoublenullablec2maxDeclination (ICRS), upper limitdegpos.eq.dec;stat.maxdoublenullablec3minDistance from coordinate origin, lower limit.AUpos.distance;stat.mindoublenullablec3maxDistance from coordinate origin, upper limitAUpos.distance;stat.maxdoublenullables_regionObsCore-like footprint, valid for celestial, spherical, or body-fixed framespos.outline;obs.fieldcharnullablec1_resol_minResolution in the first coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec1_resol_maxResolution in the first coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec2_resol_minResolution in the second coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec2_resol_maxResolution in the second coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec3_resol_minResolution in the third coordinate, lower limit.AUpos.resolution;stat.mindoublenullablec3_resol_maxResolution in the third coordinate, upper limitAUpos.resolution;stat.maxdoublenullablespatial_frame_typeFlavor of coordinate system, defines the nature of coordinates. From a controlled vocabulary, where 'none' means undefined.meta.code.class;pos.framecharnullableincidence_minIncidence angle (solar zenithal angle) during data acquisition, lower limit.degpos.incidenceAng;stat.mindoublenullableincidence_maxIncidence angle (solar zenithal angle) during data acquisition, upper limitdegpos.incidenceAng;stat.maxdoublenullableemergence_minEmergence angle during data acquisition, lower limit.degpos.emergenceAng;stat.mindoublenullableemergence_maxEmergence angle during data acquisition, upper limitdegpos.emergenceAng;stat.maxdoublenullablephase_minPhase angle during data acquisition, lower limit.degpos.phaseAng;stat.mindoublenullablephase_maxPhase angle during data acquisition, upper limitdegpos.phaseAng;stat.maxdoublenullableinstrument_host_nameStandard name of the observatory or spacecraftmeta.id;instr.obstycharnullableinstrument_nameStandard name of instrumentmeta.id;instrcharnullablemeasurement_typeUCD(s) defining the data, with multiple entries separated by hash (#) characters.meta.ucdcharnullableprocessing_levelDataset-related encoding, or simplified CODMAC calibration levelmeta.calibLevelintcreation_dateDate of first entry of this granuletime.creationcharnullablemodification_dateDate of last modification (used to handle mirroring)time.processingcharnullablerelease_dateStart of public access periodtime.releasecharnullableservice_titleTitle of resource (an acronym really, will be used to handle multiservice results)meta.titlecharnullablealt_target_nameProvides alternative target name if more common (e.g. comets); multiple identifiers can be separated by hashesmeta.id;srcunicodeCharnullablemagnitudeAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatnullableslope_parameterSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemi_major_axisOrbital semimajor axisAUphys.size.smajAxisfloatnullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mwscGlobal Survey of Star Clusters in the Milky Way MWSC presents a list of 3006 Milky Way Stellar Clusters (MWSC), found +Electronic Circulars.1200000designationAsteroid number or provisional designation.meta.id;meta.maincharnullablemagAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatindexednullableslopeSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemimaj_axOrbital semimajor axisAUphys.size.smajAxisfloatindexednullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablenameHuman-readable designation of the Asteroid.meta.idunicodeCharindexednullablelast_obsDate of last observationatime.epoch;obsfloatnullablemwscGlobal Survey of Star Clusters in the Milky Way MWSC presents a list of 3006 Milky Way Stellar Clusters (MWSC), found in the 2MAst (2MASS with Astrometry) catalogue. The target list was compiled on the basis of present-day lists of open, globular and candidate clusters. For confirmed clusters we determined a homogeneous @@ -1214,7 +1221,7 @@ These observations belong to more than 6000 different objects. The database consists of three tables: The main table ("masers"), interferometric followup observations ("maps") and monitoring programs ("monitor").ohmaser.bibrefsBibliographic and other metadata on the sources of the data in the -masers table.314ref_keyInternal key for the papercharindexedprimarybibcodeBibliographic reference to the data sourcemeta.bibcharnullablemodificationsModifications applied to data given in papercharnullablecommentsCompilators' CommentscharnullabletextrefHuman-readable reference to workcharnullabledet1612Sources detected at 1612 MHzintnullablendet1612Sources not detected at 1612 MHzintnullabledet1665Sources detected at 1665 MHzintnullablendet1665Sources not detected at 1665 MHzintnullabledet1667Sources detected at 1667 MHzintnullablendet1667Sources not detected at 1667 MHzintnullablecoosrcSource of coordinates given in databasecharnullableinputtablesTables evaluated from cited papercharnullable
ohmaser.masersMaser data proper.13655measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintflagNon-null if this measurement is considered the best available at a particular frequency. Lower means higher confidence.meta.codeshortnullablesource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharfrequencyObserved frequencyMHzem.freqintnullablespec_typeS -- Single peak of maser emission; D -- Double peak of maser emission; I -- Irregular spectral profile, multiple emission peaks.meta.code;src.spTypecharnullablera_rawJ2000 RApos.eq.racharnullablede_rawJ2000 Decpos.eq.deccharnullableveloc_blueVelocity of the blue-shifted maser peak. For single-peak masers it contains the line velocity.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_redVelocity of the red-shifted maser peak in km/s. It contains the line velocity for a single peak maser if it corresponds to the red-shifted peak in other observations.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_centralRadial velocity of the central star. If veloc_central is not given in the reference, it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_shellOutflow Velocity of the shell. If vexp is not given in the reference it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_errUncertainty of velocity values. Taken from the velocity resolution of the observation. It is actually a lower limit of the uncertainty, because the lines are usually much broader than velocity resolution of the observing equipment.km/sstat.error;phys.veloc.expansion;pos.bodyrcfloatnullableflux_dens_flagNULL -- flux density columns contain detections; < -- non-detection at level flux density blue (3 sigma); > -- flux density blue contains a lower limit for the flux; = -- source only gives fluxes; . -- flux density blue contains probable detection; : -- flux density red contains probable detection; & -- both flux densities contain probable detectionsmeta.codecharnullableflux_dens_blueFlux Density of the blue-shifted maser peak. For single-peak masers it contains its flux density.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableflux_dens_redFlux Density of the red-shifted maser peak. It contains the flux density for a single peak maser, if it corresponds to the red-shifted peak in other observations.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_redIntegrated flux of red peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_blueIntegrated flux of blue peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullablerapubRA of object, from sourcedegpos.eq.rafloatnullabledepubDec of object, from sourcedegpos.eq.decfloatnullableraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoubleindexednullablemapurlURL to information on an interferometric followup observation for this object.meta.ref.urlcharnullablemonitorurlURL to information on a monitor programme for this object.meta.ref.urlcharnullableohmaser.bibrefsref_keyref_key
ohmaser.mapsTable of interferometric measurements included.271measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableinstrumentName of the interferometer usedmeta.id;instrcharnullableresolutionSpatial resolution of the observationmasinstr.paramfloatnullablenon_det_flag< if observation is a non-detection.meta.codecharnullablermsRMS sensitivity of the observationJyinstr.sensitivityfloatnullablen_mapsNumber of maps obtained between obs_date_start and obs_date_endmeta.number;obsshortnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullableohmaser.maserssource_nosource_no
ohmaser.monitorTable of measurements included from monitoring programs.180measure_noUnique measurement identifiermeta.id;meta.mainintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharsource_noUnique, artificial source identifiermeta.codeintraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullablemax_flux_dens_flag< if max_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemax_flux_dens_peakMaximal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.maxfloatnullablemin_flux_dens_flag< if min_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemin_flux_dens_peakMinimal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.minfloatnullableohmaser.maserssource_nosource_no
onebigb1BIGB: First Brazil-ICRANet Gamma-Ray Blazar Catalogue +masers table.314ref_keyInternal key for the papercharindexedprimarybibcodeBibliographic reference to the data sourcemeta.bibcharnullablemodificationsModifications applied to data given in papercharnullablecommentsCompilators' CommentscharnullabletextrefHuman-readable reference to workcharnullabledet1612Sources detected at 1612 MHzintnullablendet1612Sources not detected at 1612 MHzintnullabledet1665Sources detected at 1665 MHzintnullablendet1665Sources not detected at 1665 MHzintnullabledet1667Sources detected at 1667 MHzintnullablendet1667Sources not detected at 1667 MHzintnullablecoosrcSource of coordinates given in databasecharnullableinputtablesTables evaluated from cited papercharnullableohmaser.mapsTable of interferometric measurements included.271measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableinstrumentName of the interferometer usedmeta.id;instrcharnullableresolutionSpatial resolution of the observationmasinstr.paramfloatnullablenon_det_flag< if observation is a non-detection.meta.codecharnullablermsRMS sensitivity of the observationJyinstr.sensitivityfloatnullablen_mapsNumber of maps obtained between obs_date_start and obs_date_endmeta.number;obsshortnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullableohmaser.maserssource_nosource_no
ohmaser.masersMaser data proper.13655measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintflagNon-null if this measurement is considered the best available at a particular frequency. Lower means higher confidence.meta.codeshortnullablesource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharfrequencyObserved frequencyMHzem.freqintnullablespec_typeS -- Single peak of maser emission; D -- Double peak of maser emission; I -- Irregular spectral profile, multiple emission peaks.meta.code;src.spTypecharnullablera_rawJ2000 RApos.eq.racharnullablede_rawJ2000 Decpos.eq.deccharnullableveloc_blueVelocity of the blue-shifted maser peak. For single-peak masers it contains the line velocity.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_redVelocity of the red-shifted maser peak in km/s. It contains the line velocity for a single peak maser if it corresponds to the red-shifted peak in other observations.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_centralRadial velocity of the central star. If veloc_central is not given in the reference, it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_shellOutflow Velocity of the shell. If vexp is not given in the reference it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_errUncertainty of velocity values. Taken from the velocity resolution of the observation. It is actually a lower limit of the uncertainty, because the lines are usually much broader than velocity resolution of the observing equipment.km/sstat.error;phys.veloc.expansion;pos.bodyrcfloatnullableflux_dens_flagNULL -- flux density columns contain detections; < -- non-detection at level flux density blue (3 sigma); > -- flux density blue contains a lower limit for the flux; = -- source only gives fluxes; . -- flux density blue contains probable detection; : -- flux density red contains probable detection; & -- both flux densities contain probable detectionsmeta.codecharnullableflux_dens_blueFlux Density of the blue-shifted maser peak. For single-peak masers it contains its flux density.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableflux_dens_redFlux Density of the red-shifted maser peak. It contains the flux density for a single peak maser, if it corresponds to the red-shifted peak in other observations.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_redIntegrated flux of red peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_blueIntegrated flux of blue peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullablerapubRA of object, from sourcedegpos.eq.rafloatnullabledepubDec of object, from sourcedegpos.eq.decfloatnullableraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoubleindexednullablemapurlURL to information on an interferometric followup observation for this object.meta.ref.urlcharnullablemonitorurlURL to information on a monitor programme for this object.meta.ref.urlcharnullableohmaser.bibrefsref_keyref_key
ohmaser.monitorTable of measurements included from monitoring programs.180measure_noUnique measurement identifiermeta.id;meta.mainintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharsource_noUnique, artificial source identifiermeta.codeintraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullablemax_flux_dens_flag< if max_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemax_flux_dens_peakMaximal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.maxfloatnullablemin_flux_dens_flag< if min_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemin_flux_dens_peakMinimal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.minfloatnullableohmaser.maserssource_nosource_no
onebigb1BIGB: First Brazil-ICRANet Gamma-Ray Blazar Catalogue This catalog presents the 1-100 GeV spectral energy distribution (SED) for a population of 148 high-synchrotron-peaked blazars (HSPs) recently detected with Fermi-LAT as part of the @@ -1321,8 +1328,8 @@ field of view of roughly 1 kpc across, at 10pc physical resolution. In addition to the calibrated data cubes, we provide flux maps of the Hβ, [OIII]5007, Hα, [NII]6583, [SII]6716 and [SII]6730 line emission. Line fluxes have not been corrected for dust extinction. All data products -have associated error maps.ppakm31.maps Extracted narrow-band images.30accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsRepresentative date of observation. In reality, data contributing to this observation has typically been obtained over about a month.dtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldInternal designation of the field being observed.charnullablecube_idIVOA publisher DID of the originating cube.meta.ref.ivoidcharnullablecube_linkDatalink URL for the cube this line was extracted from. This can be used to access the cube using datalink.charnullable
ppakm31.cubes Spectral cubes of the fields. Look for these with full metadata in -the ivoa.obscore table, obs_collection 'ppakm31 cubes'.5accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullable
ppmxThe PPM-Extended (PPMX) catalogue of positions and proper motionsPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS +have associated error maps.ppakm31.cubes Spectral cubes of the fields. Look for these with full metadata in +the ivoa.obscore table, obs_collection 'ppakm31 cubes'.5accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullable
ppakm31.maps Extracted narrow-band images.30accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsRepresentative date of observation. In reality, data contributing to this observation has typically been obtained over about a month.dtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldInternal designation of the field being observed.charnullablecube_idIVOA publisher DID of the originating cube.meta.ref.ivoidcharnullablecube_linkDatalink URL for the cube this line was extracted from. This can be used to access the cube using datalink.charnullable
ppmxThe PPM-Extended (PPMX) catalogue of positions and proper motionsPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS system containing astrometric and photometric information. Its limiting magnitude is about 15.2 in the GSC photometric system.ppmx.dataPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS system containing astrometric and photometric information. Its @@ -1353,7 +1360,10 @@ here as separate tables, map6 through map10. A union of the coverage is provided as map_union. Use its coverage column to match against other tables. -See http://argonaut.rc.fas.harvard.edu/ for more details.
prdust.map6 The HEALPix map for order 6 (nside=64); the pixel scale is about 55'. +See http://argonaut.rc.fas.harvard.edu/ for more details.
prdust.map10 The HEALPix map for order 10 (nside=1024); the pixel scale is about +3.4'. + +In ADQL, all array indices are 1-based.2200000healpixThe healpix (of order 10) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map6 The HEALPix map for order 6 (nside=64); the pixel scale is about 55'. In ADQL, all array indices are 1-based.74healpixThe healpix (of order 6) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map7 The HEALPix map for order 7 (nside=128); the pixel scale is about 27'. @@ -1364,10 +1374,7 @@ In ADQL, all array indices are 1-based.410192156healpixThe healpix (of order 8) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map9 The HEALPix map for order 9 (nside=512); the pixel scale is about 6.9'. -In ADQL, all array indices are 1-based.1100000healpixThe healpix (of order 9) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map10 The HEALPix map for order 10 (nside=1024); the pixel scale is about -3.4'. - -In ADQL, all array indices are 1-based.2200000healpixThe healpix (of order 10) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map_unionJoined Bayestar17 3D Dust MapThis is a view of the dust maps in the five orders, generated by +In ADQL, all array indices are 1-based.1100000healpixThe healpix (of order 9) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map_unionJoined Bayestar17 3D Dust MapThis is a view of the dust maps in the five orders, generated by splitting the larger pixels from the higher orders into HEALPixes of order 10. This means, in particular, that the spatial resolution for all pixels with original_order!=10. Use this for convenient joins to @@ -1375,22 +1382,20 @@ other tables.healpixThe healpix parameters (effective temperature, surface gravity, overall metallicity), radial velocities, chemical abundances and distances. Observations between 2003 and 2013 were used to build the five RAVE -data releases.
rave.mainThe RAVE object catalog of radial velocities, surface gravities, and -chemical parameters for about 500000 stars, data release 5. We have -removed almost all fields originating from crossmatches (as this is -intended for use within our TAP service, where users can do the -crossmatches themselves). Also, some obviously buggy columns (e.g., -footprint_flag) were dropped. +data releases.
rave.dr2Data Release 2 +The second data release of RAVE contains spectroscopic radial velocities +for 49327 stars in the Milky-Way southern hemisphere using the 6dF +instrument at the AAO. Stellar parameters are published for a set of 21121 +stars belonging to the second year of observation. -Note that columns with names ending in _k originate from the stellar -parameters pipeline, those with names ending in _c come from the -chemical pipeline. Columns ending in _n_k indicate calibrated values.520629rave_obs_idUnique Identifier for RAVE objects: Observation Date, Fieldname, Fibernumbermeta.id;meta.maincharindexedprimaryraveidMain RAVE identifiermeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablestddev_rvStandard deviation in HRV from 10 resampled spectrakm/sstat.stdev;spect.dopplerVeloc;pos.heliocentricfloatnullablemad_rvMedian absolute deviation in HRV from 10 resampled spectrakm/sstat.fit.residual;spect.dopplerVeloc;pos.heliocentric;stat.medianfloatnullablestddev_teff_kStandard deviation in Teff_K from 10 resampled spectraKstat.stdev;phys.temperature.effectivefloatnullablemad_teff_kMedian absolute deviation in Teff_K from 10 resampled spectraKstat.fit.residual;phys.temperature.effective;stat.medianfloatnullablestddev_logg_kStandard deviation in Teff_K from 10 resampled spectrastat.stdev;phys.gravityfloatnullablemad_logg_kMedian absolute deviation in metallicity from 10 resampled spectrastat.fit.residual;phys.abund.Z;stat.medianfloatnullablestddev_met_kStandard deviation in metallicity from 10 resampled spectrastat.stdev;phys.abund.Zfloatnullablechisq_kχ² of the Stellar Parameter Pipelinestat.fit.chi2floatnullableteff_irEffective temperature from infrared flux methodKphys.temperature.effectivefloatnullablee_teff_irError in the effective temperature from infrared flux methodKstat.error;phys.temperature.effectivefloatnullableir_directInfrared temperature method: IRFM -- Temperature derived from infrared flux method; CTRL -- Temperature computed via color-Teff relations; NO -- No temperature derivation possiblemeta.codecharnullablealpha_cAlpha-enhancement from chemical pipeline (log solar ratio; 'dex')phys.abundfloatnullablefrac_cFraction of spectrum used for calculation of abundancesstat.valuefloatnullableav_schlegelTotal Extinction in V-band from 1998ApJ...500..525Smagphys.absorptionfloatnullablen_gauss_fitNumber of components required for multi-Gaussian distance modulus fit.meta.numbershortnullablegauss_mean_1Gaussian number 1 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_1Gaussian number 1 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_2Gaussian number 2 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_2Gaussian number 2 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_3Gaussian number 3 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_3Gaussian number 3 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablerep_flagTrue if the object was observed multiple timesmeta.code.qualbooleancluster_flagTrue if this was a targeted cluster observationmeta.code.qualbooleanid_tgasTGAS target designationmeta.id.crosslongnullable
rave.dr4The RAVE object catalog, data release 4. +This data collection has been superceded by RAVE data release 3 +(`table rave.dr </__system__/dc_tables/show/tableinfo/rave.dr3>`_ +in the data center). -Note that columns with names ending in _k originate from the stellar -parameters pipeline, those with names ending in _c come from the -chemical pipeline, those with name ending in _sparv come from the -radial velocity pipeline. Names ending in _n_k indicate calibrated -values.482194nameTarget designationmeta.id;meta.maincharindexedprimaryaltnameRAVE target designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablecorrelation_coeffTonry & Davis R correlation coefficientstat.fit.paramfloatnullablepeak_heightHeight of the correlation peak.stat.correlationfloatnullablepeak_widthWidth of the correlation peak.stat.correlationfloatnullableskyhrvMeasured heliocentry radial velocity of the sky.km/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_skyhrvError in the measured heliocentric velocity of the sky.km/sstat.error;spect.dopplerVeloc;obs.field;pos.heliocentricfloatnullabletdccskyTonry & Davis R Sky correlation coefficient.stat.fit.paramfloatnullablecorrection_rvZero point correction applied to the radial velocity solutions (see 2011AJ....141..187S).km/sarith.zpfloatnullablezeropoint_flagQuality flag for Zero point correctionmeta.codecharnullableteff_sparvEffective temperature as determined by the radial velocity pipeline.Kphys.temperature.effectivefloatnullablelogg_sparvLog gravity as determined by the radial velocity pipeline.phys.gravityfloatnullablealpha_sparvMetallicity as determined by the radial velocity pipeline.phys.abund.ZfloatnullableageLogarithm of age (from 2014MNRAS.437..351B)log(a)time.agefloatnullablee_ageError in Age (from 2014MNRAS.437..351B)log(a)stat.error;time.agefloatnullablemassMass (from 2014MNRAS.437..351B)solMassphys.massfloatnullablee_massError Mass (from 2014MNRAS.437..351B)solMassstat.error;phys.massfloatnullable
rave.dr3 +The data published here comprises all original RAVE data. Columns +in the data release that resulted from crossmatching were left out. + +For details, see 2008MNRAS.391..793S.51829nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvHRV errorkm/sstat.errorfloatnullablepmraProper motion in RAmas/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAmas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationmas/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationmas/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (0 - no PM; 1 - Tycho-2; 2 - Supercosmos; 3 - STARNET 2.0; 4 - GSC1.2x2MASS; 5 - UCAC-2)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationdtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;instr.paramshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablem_h_uncalUncalibrated [M/H]phys.abund.Fefloatnullablealfa_fealpha enhancement [{alpha}/Fe]phys.abundfloatnullablem_hCalibrated [M/H], Sun=1phys.abund.Fefloatnullablechi2chi squarestat.fit.chi2doublenullablesnrCorrected signal to noisestat.snrfloatnullabletdccTonry-Davis correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectra signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag [dispersion around correction <1 (A), 1..2 (B), 2..3 (C), >3 km/s (D); E - less than 15 fibers available.]meta.codecharnullablezp250 fibers group to which the fiber belongs zero point correction flagmeta.codecharnullablegapwarningFiber is close to a 15 fibers gapmeta.codebooleanqualSpectra quality flag [a - asymmetric Ca lines; c - cosmic ray pollution; e - emission line spectra; n - noise dominated spectra; l - no lines visible; w - weak lines; g - strong ghost; t - bad template fit; s - strong residual sky emission; cc - bad continuum; r - red part of the spectra shows problem; b - blue part of the spectra shows problem; p - possible binary/doubled lined; x - peculiar object;]meta.code.qualcharnullable
rave.dr3 The third data release of RAVE contains spectroscopic radial velocities for 83072 stars in the Milky-Way southern hemisphere using the 6dF instrument at the AAO. @@ -1402,27 +1407,29 @@ in the data center). Columns in the data release that resulted from crossmatching were left out. -For details, see 2011AJ....141..187S.83072nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (see note)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationyrtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;obs.fieldshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablemetMetallicity [m/H]phys.abund.Fefloatnullablealphaalpha enhancement [{alpha}/Fe]phys.abundfloatnullablechi2Chi square of continuum fitstat.fit.chi2doublenullablesnr2DR2 signal to noise ratiostat.snrfloatnullablesnrPre-flux calibration signal to noisestat.snrfloatnullabletdccTonry-Davis R correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectrum signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag (see note)meta.codecharnullablequalSpectrum quality flag (see note)meta.code.qualcharnullablemaskflagFraction of spectrum unaffected by continuum problems (see note)meta.code.qualfloatnullable
rave.dr2Data Release 2 -The second data release of RAVE contains spectroscopic radial velocities -for 49327 stars in the Milky-Way southern hemisphere using the 6dF -instrument at the AAO. Stellar parameters are published for a set of 21121 -stars belonging to the second year of observation. - -This data collection has been superceded by RAVE data release 3 -(`table rave.dr </__system__/dc_tables/show/tableinfo/rave.dr3>`_ -in the data center). +For details, see 2011AJ....141..187S.83072nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (see note)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationyrtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;obs.fieldshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablemetMetallicity [m/H]phys.abund.Fefloatnullablealphaalpha enhancement [{alpha}/Fe]phys.abundfloatnullablechi2Chi square of continuum fitstat.fit.chi2doublenullablesnr2DR2 signal to noise ratiostat.snrfloatnullablesnrPre-flux calibration signal to noisestat.snrfloatnullabletdccTonry-Davis R correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectrum signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag (see note)meta.codecharnullablequalSpectrum quality flag (see note)meta.code.qualcharnullablemaskflagFraction of spectrum unaffected by continuum problems (see note)meta.code.qualfloatnullable
rave.dr4The RAVE object catalog, data release 4. -The data published here comprises all original RAVE data. Columns -in the data release that resulted from crossmatching were left out. +Note that columns with names ending in _k originate from the stellar +parameters pipeline, those with names ending in _c come from the +chemical pipeline, those with name ending in _sparv come from the +radial velocity pipeline. Names ending in _n_k indicate calibrated +values.482194nameTarget designationmeta.id;meta.maincharindexedprimaryaltnameRAVE target designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablecorrelation_coeffTonry & Davis R correlation coefficientstat.fit.paramfloatnullablepeak_heightHeight of the correlation peak.stat.correlationfloatnullablepeak_widthWidth of the correlation peak.stat.correlationfloatnullableskyhrvMeasured heliocentry radial velocity of the sky.km/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_skyhrvError in the measured heliocentric velocity of the sky.km/sstat.error;spect.dopplerVeloc;obs.field;pos.heliocentricfloatnullabletdccskyTonry & Davis R Sky correlation coefficient.stat.fit.paramfloatnullablecorrection_rvZero point correction applied to the radial velocity solutions (see 2011AJ....141..187S).km/sarith.zpfloatnullablezeropoint_flagQuality flag for Zero point correctionmeta.codecharnullableteff_sparvEffective temperature as determined by the radial velocity pipeline.Kphys.temperature.effectivefloatnullablelogg_sparvLog gravity as determined by the radial velocity pipeline.phys.gravityfloatnullablealpha_sparvMetallicity as determined by the radial velocity pipeline.phys.abund.ZfloatnullableageLogarithm of age (from 2014MNRAS.437..351B)log(a)time.agefloatnullablee_ageError in Age (from 2014MNRAS.437..351B)log(a)stat.error;time.agefloatnullablemassMass (from 2014MNRAS.437..351B)solMassphys.massfloatnullablee_massError Mass (from 2014MNRAS.437..351B)solMassstat.error;phys.massfloatnullable
rave.mainThe RAVE object catalog of radial velocities, surface gravities, and +chemical parameters for about 500000 stars, data release 5. We have +removed almost all fields originating from crossmatches (as this is +intended for use within our TAP service, where users can do the +crossmatches themselves). Also, some obviously buggy columns (e.g., +footprint_flag) were dropped. -For details, see 2008MNRAS.391..793S.51829nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvHRV errorkm/sstat.errorfloatnullablepmraProper motion in RAmas/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAmas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationmas/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationmas/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (0 - no PM; 1 - Tycho-2; 2 - Supercosmos; 3 - STARNET 2.0; 4 - GSC1.2x2MASS; 5 - UCAC-2)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationdtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;instr.paramshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablem_h_uncalUncalibrated [M/H]phys.abund.Fefloatnullablealfa_fealpha enhancement [{alpha}/Fe]phys.abundfloatnullablem_hCalibrated [M/H], Sun=1phys.abund.Fefloatnullablechi2chi squarestat.fit.chi2doublenullablesnrCorrected signal to noisestat.snrfloatnullabletdccTonry-Davis correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectra signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag [dispersion around correction <1 (A), 1..2 (B), 2..3 (C), >3 km/s (D); E - less than 15 fibers available.]meta.codecharnullablezp250 fibers group to which the fiber belongs zero point correction flagmeta.codecharnullablegapwarningFiber is close to a 15 fibers gapmeta.codebooleanqualSpectra quality flag [a - asymmetric Ca lines; c - cosmic ray pollution; e - emission line spectra; n - noise dominated spectra; l - no lines visible; w - weak lines; g - strong ghost; t - bad template fit; s - strong residual sky emission; cc - bad continuum; r - red part of the spectra shows problem; b - blue part of the spectra shows problem; p - possible binary/doubled lined; x - peculiar object;]meta.code.qualcharnullable
rosatROSAT results +Note that columns with names ending in _k originate from the stellar +parameters pipeline, those with names ending in _c come from the +chemical pipeline. Columns ending in _n_k indicate calibrated values.520629rave_obs_idUnique Identifier for RAVE objects: Observation Date, Fieldname, Fibernumbermeta.id;meta.maincharindexedprimaryraveidMain RAVE identifiermeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablestddev_rvStandard deviation in HRV from 10 resampled spectrakm/sstat.stdev;spect.dopplerVeloc;pos.heliocentricfloatnullablemad_rvMedian absolute deviation in HRV from 10 resampled spectrakm/sstat.fit.residual;spect.dopplerVeloc;pos.heliocentric;stat.medianfloatnullablestddev_teff_kStandard deviation in Teff_K from 10 resampled spectraKstat.stdev;phys.temperature.effectivefloatnullablemad_teff_kMedian absolute deviation in Teff_K from 10 resampled spectraKstat.fit.residual;phys.temperature.effective;stat.medianfloatnullablestddev_logg_kStandard deviation in Teff_K from 10 resampled spectrastat.stdev;phys.gravityfloatnullablemad_logg_kMedian absolute deviation in metallicity from 10 resampled spectrastat.fit.residual;phys.abund.Z;stat.medianfloatnullablestddev_met_kStandard deviation in metallicity from 10 resampled spectrastat.stdev;phys.abund.Zfloatnullablechisq_kχ² of the Stellar Parameter Pipelinestat.fit.chi2floatnullableteff_irEffective temperature from infrared flux methodKphys.temperature.effectivefloatnullablee_teff_irError in the effective temperature from infrared flux methodKstat.error;phys.temperature.effectivefloatnullableir_directInfrared temperature method: IRFM -- Temperature derived from infrared flux method; CTRL -- Temperature computed via color-Teff relations; NO -- No temperature derivation possiblemeta.codecharnullablealpha_cAlpha-enhancement from chemical pipeline (log solar ratio; 'dex')phys.abundfloatnullablefrac_cFraction of spectrum used for calculation of abundancesstat.valuefloatnullableav_schlegelTotal Extinction in V-band from 1998ApJ...500..525Smagphys.absorptionfloatnullablen_gauss_fitNumber of components required for multi-Gaussian distance modulus fit.meta.numbershortnullablegauss_mean_1Gaussian number 1 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_1Gaussian number 1 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_2Gaussian number 2 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_2Gaussian number 2 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_3Gaussian number 3 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_3Gaussian number 3 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablerep_flagTrue if the object was observed multiple timesmeta.code.qualbooleancluster_flagTrue if this was a targeted cluster observationmeta.code.qualbooleanid_tgasTGAS target designationmeta.id.crosslongnullablerosatROSAT results ROSAT was an orbiting x-ray observatory active in the 1990s. We provide a table of all photons observed during ROSAT's all-sky survey (RASS) as well as images of both survey and pointed observations. For ROSAT data products, see -http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-surveyrosat.photonsA table of x-ray photons detected by ROSAT88000000raj2000Right Ascension, equinox 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination, equinox 2000.0degpos.eq.dec;meta.maindoubleindexednullabledetection_timeTime the photon was detected, in Julian years.yrtime.startdoubleindexednullableenergy_corEnergy of incoming photon (corrected) [keV]keVphys.energy;em.X-rayfloatindexednullableposition_errorTotal positional error, 1{sigma} arcsecarcsecstat.error;pos.eqfloatnullableglongGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablepulseht_channelChannel of the pulse height. This is a measure for the energy of the incoming photon, where one channel corresponds to about 10 eV; a pulse height channel of 127 thus indicates an incoming photon of about 1.3 keV.shortnullableexposure_timeROSAT cluster survey exposure timestime.duration;obs.exposurefloatnullablefield_idRASS field idmeta.id;obs.fieldshortnullableixX pixel coordinatepixelpos.cartesian.x;instr.detshortnullableiyY pixel coordinatepixelpos.cartesian.y;instr.detshortnullableidPhoton identifier (a combination of observation date and detector coordinates)meta.id;meta.mainlongindexedprimary
rosat.imagesMetadata for ROSAT pointed observations and the ROSAT All Sky Survey -(RASS) images115678accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableseqnoROR sequence numbermeta.id;obsintindexedfollowupNumber of follow-up observation (0=first observation, NULL=mispointing)meta.code;obsintnullableobstypeType of data in the file (associated products available through datalink of by querying through seqno)meta.code;meta.filecharnullablepubdidPublisher dataset identifier (this lets you access datalink services and the like)meta.idcharnullabledlurlLink to a datalink document for this dataset, this lets you access associate data)meta.ref.urlcharnullable
rrGAVO RegTAP Service +http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-surveyrosat.imagesMetadata for ROSAT pointed observations and the ROSAT All Sky Survey +(RASS) images115678accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableseqnoROR sequence numbermeta.id;obsintindexedfollowupNumber of follow-up observation (0=first observation, NULL=mispointing)meta.code;obsintnullableobstypeType of data in the file (associated products available through datalink of by querying through seqno)meta.code;meta.filecharnullablepubdidPublisher dataset identifier (this lets you access datalink services and the like)meta.idcharnullabledlurlLink to a datalink document for this dataset, this lets you access associate data)meta.ref.urlcharnullable
rosat.photonsA table of x-ray photons detected by ROSAT88000000raj2000Right Ascension, equinox 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination, equinox 2000.0degpos.eq.dec;meta.maindoubleindexednullabledetection_timeTime the photon was detected, in Julian years.yrtime.startdoubleindexednullableenergy_corEnergy of incoming photon (corrected) [keV]keVphys.energy;em.X-rayfloatindexednullableposition_errorTotal positional error, 1{sigma} arcsecarcsecstat.error;pos.eqfloatnullableglongGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablepulseht_channelChannel of the pulse height. This is a measure for the energy of the incoming photon, where one channel corresponds to about 10 eV; a pulse height channel of 127 thus indicates an incoming photon of about 1.3 keV.shortnullableexposure_timeROSAT cluster survey exposure timestime.duration;obs.exposurefloatnullablefield_idRASS field idmeta.id;obs.fieldshortnullableixX pixel coordinatepixelpos.cartesian.x;instr.detshortnullableiyY pixel coordinatepixelpos.cartesian.y;instr.detshortnullableidPhoton identifier (a combination of observation date and detector coordinates)meta.id;meta.mainlongindexedprimary
rrGAVO RegTAP Service Tables containing the information in the IVOA Registry. To query these tables, use `our TAP service`_. @@ -1430,38 +1437,38 @@ For more information and example queries, see the `RegTAP specification`_. .. _our TAP service: /__system__/tap/run/info -.. _RegTAP specification: http://www.ivoa.net/documents/RegTAP/ivo://ivoa.net/std/RegTAP#1.1rr.registries Administrative table: publishing registries we harvest, together with -the dates of last full and incremental harvests.ivo://ivoa.net/std/RegTAP#1.153ivoidIVOID of the registry.charindexedprimaryaccessurlURL of the registry's OAI-PMH endpoint.charnullabletitleName of the registry.unicodeCharnullablelast_full_harvestDate and time of the last full harvest of the registry.charnullablelast_inc_harvestDate and time of the last incremental harvest of the registry.charnullable
rr.authorities A mapping between the registries and the authorities they claim to -manage.ivo://ivoa.net/std/RegTAP#1.1142ivoidIVOID of the registry.charnullablemanaged_authorityAn authority this registry claims to serve.charindexedprimaryrr.registriesivoidivoid
rr.resource The resources (like services, data collections, organizations) -present in this registry.xpath:/24138ivoidUnambiguous reference to the resource conforming to the IVOA standard for identifiers.xpath:identifiercharindexedprimaryres_typeResource type (something like vg:authority, vs:catalogservice, etc).xpath:@xsi:typecharnullablecreatedThe UTC date and time this resource metadata description was created.xpath:@createdcharnullableshort_nameA short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).xpath:shortNamecharindexednullableres_titleThe full name given to the resource.xpath:titleunicodeCharindexednullableupdatedThe UTC date this resource metadata description was last updated.xpath:@updatedcharnullablecontent_levelA hash-separated list of content levels specifying the intended audience.xpath:content/contentLevelcharnullableres_descriptionAn account of the nature of the resource.xpath:content/descriptionunicodeCharindexednullablereference_urlURL pointing to a human-readable document describing this resource.xpath:content/referenceURLcharnullablecreator_seqThe creator(s) of the resource in the order given by the resource record author, separated by semicolons.xpath:curation/creator/nameunicodeCharindexednullablecontent_typeA hash-separated list of natures or genres of the content of the resource.xpath:content/typecharnullablesource_formatThe format of source_value. This, in particular, can be ``bibcode''.xpath:content/source/@formatcharnullablesource_valueA bibliographic reference from which the present resource is derived or extracted.xpath:content/sourceunicodeCharnullableres_versionLabel associated with creation or availablilty of a version of a resource.xpath:curation/versioncharnullableregion_of_regardA single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.degxpath:coverage/regionOfRegardfloatnullablewavebandA hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.xpath:coverage/wavebandcharnullablerightsA statement of usage conditions (license, attribution, embargo, etc).xpath:/rightscharnullablerights_uriA URI identifying a license the data is made available under.xpath:/rights/@rightsURIcharnullableharvested_fromIVOID of the registry this record came from.charnullablerr.registriesharvested_fromivoid
rr.res_role Entities (persons or organizations) operating on resources: creators, -contacts, publishers, contributors.ivo://ivoa.net/std/RegTAP#1.195827ivoidThe parent resource.xpath:/identifiercharindexednullablerole_nameThe real-world name or title of a person or organization.unicodeCharindexednullablerole_ivoidAn IVOA identifier of a person or organization.charnullablestreet_addressA mailing address for a person or organization.unicodeCharnullableemailAn email address the entity can be reached at.charnullabletelephoneA telephone number the entity can be reached at.charnullablelogoURL pointing to a graphical logo, which may be used to help identify the entity.charnullablebase_roleThe role played by this entity; this is one of contact, publisher, contributor, or creator.charindexednullablerr.resourceivoidivoid
rr.res_subject Topics, object types, or other descriptive keywords about the -resource.xpath:/content/55057ivoidThe parent resource.xpath:/identifiercharindexednullableres_subjectTopics, object types, or other descriptive keywords about the resource.xpath:subjectcharindexednullablerr.resourceivoidivoid
rr.subject_uat res_subject mapped to the UAT. This is based on a manual mapping of -keywords found in 2020, where subjects not mappable were dropped. This -is a non-standard, local extension. Don't base your procedures on it, -we will tear it down once there is sufficient takeup of the UAT in the -VO.ivo://ivoa.net/std/RegTAP#1.151571ivoidThe parent resource.xpath:/identifiercharindexednullableuat_conceptTerm from http://www.ivoa.net/rdf/uat; most of these resulted from mapping non-UAT designations.charindexednullablerr.resourceivoidivoid
rr.capability Pieces of behaviour of a resource.xpath:/capability/95817ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexAn arbitrary identifier of this capability within the resource.shortindexedprimarycap_typeThe type of capability covered here. If looking for endpoints implementing a certain standard, you should not use this column but rather match against standard_id.xpath:@xsi:typecharnullablecap_descriptionA human-readable description of what this capability provides as part of the over-all service.xpath:descriptionunicodeCharnullablestandard_idA URI for a standard this capability conforms to.xpath:@standardIDcharnullablerr.resourceivoidivoid
rr.res_schema Sets of tables related to resources.xpath:/tableset/schema/2137ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexAn arbitrary identifier for the res_schema rows belonging to a resource.shortindexedprimaryschema_descriptionA free text description of the tableset explaining in general how all of the tables are related.xpath:descriptionunicodeCharnullableschema_nameA name for the set of tables.xpath:name charnullableschema_titleA descriptive, human-interpretable name for the table set.xpath:titleunicodeCharnullableschema_utypeAn identifier for a concept in a data model that the data in this schema as a whole represent.xpath:utypecharnullablerr.resourceivoidivoid
rr.res_table (Relational) tables that are part of schemata or resources.xpath:/(tableset/schema/|)table/60176ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexIndex of the schema this table belongs to, if it belongs to a schema (otherwise NULL).shortnullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharnullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharnullabletable_indexAn arbitrary identifier for the tables belonging to a resource.shortindexedprimarytable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharnullabletable_typeA name for the role this table plays. Recognized values include "output", indicating this table is output from a query; "base_table", indicating a table whose records represent the main subjects of its schema; and "view", indicating that the table represents a useful combination or subset of other tables. Other values are allowed.xpath:@typecharnullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullablenrowsAn estimate for the number of rows in the table.xpath:nrowslongnullablerr.resourceivoidivoid
rr.table_column Metadata on columns of a resource's tables.xpath:/(tableset/schema/|)/table/column/1300000ivoidThe parent resource.xpath:/identifiercharindexednullabletable_indexIndex of the table this column belongs to.shortnameThe name of the column.xpath:namecharindexednullableucdA unified content descriptor that describes the scientific content of the column.xpath:ucdcharindexednullableunitThe unit associated with all values in the column.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this column represents.xpath:utypecharnullablestdIf 1, the meaning and use of this column is reserved and defined by a standard model. If 0, it represents a database-specific column that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the column.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this column contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullabletype_systemThe type system used, as a QName with a canonical prefix; this will ususally be one of vs:simpledatatype, vs:votabletype, and vs:taptype.xpath:dataType/@xsi:typecharnullableflagHash-separated keywords representing traits of the column. Recognized values include "indexed", "primary", and "nullable".xpath:flagcharnullablecolumn_descriptionA free-text description of the column's contents.xpath:descriptionunicodeCharindexednullablerr.res_tableivoidivoidtable_indextable_index
rr.g_num_stat An experimental table containing advanced statistics for numeric +.. _RegTAP specification: http://www.ivoa.net/documents/RegTAP/ivo://ivoa.net/std/RegTAP#1.1
rr.alt_identifier An alternate identifier associated with this record. This can be a +resiource identifier like a DOI (in URI form, e.g., +doi:10.1016/j.epsl.2011.11.037), or a person identifier of a creator +(typically an ORCID in URI form, e.g., orcid:000-0000-0000-000X).xpath:/(curation/creator/|)altIdentifier63ivoidThe parent resource.xpath:/identifiercharindexednullablealt_identifierAn identifier for the resource or an entity related to the resource in URI form.charindexednullablerr.resourceivoidivoid
rr.authorities A mapping between the registries and the authorities they claim to +manage.ivo://ivoa.net/std/RegTAP#1.1142ivoidIVOID of the registry.charnullablemanaged_authorityAn authority this registry claims to serve.charindexedprimaryrr.registriesivoidivoid
rr.capability Pieces of behaviour of a resource.xpath:/capability/95817ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexAn arbitrary identifier of this capability within the resource.shortindexedprimarycap_typeThe type of capability covered here. If looking for endpoints implementing a certain standard, you should not use this column but rather match against standard_id.xpath:@xsi:typecharnullablecap_descriptionA human-readable description of what this capability provides as part of the over-all service.xpath:descriptionunicodeCharnullablestandard_idA URI for a standard this capability conforms to.xpath:@standardIDcharnullablerr.resourceivoidivoid
rr.g_num_stat An experimental table containing advanced statistics for numeric table columns. This is only available for very few tables at this point. Note that the values reported here may be estimates based on a subeset -of the table rows.ivo://ivoa.net/std/RegTAP#1.11052ivoidThe parent resource.xpath:/identifiercharnullabletable_indexIndex of the table this column belongs to.shortnameName of the column (see rr.table_column for more metadata).charindexednullablefill_factorAn estimate for the ratio of non-NULL values in this column to the number of rows in the table.floatnullablemin_valueThe largest value found in the column.floatnullablepercentile03An estimate for the value in the 3rd percentile of the column's distribution (for a Gaussian, roughly the lower limit of a 2σ interval).floatindexednullablemedianAn estimate for the median value (or 50th percentile) of the column's distributionfloatindexednullablepercentile97An estimate for the value in the 97th percentile of the column's distribution (for a Gaussian, roughly the upper limit of a 2σ interval).floatindexednullablemax_valueThe largest value found in the column.floatnullablerr.res_tableivoidivoidtable_indextable_index
rr.res_detail XPath-value pairs for members of resource or capability and their +of the table rows.ivo://ivoa.net/std/RegTAP#1.11052ivoidThe parent resource.xpath:/identifiercharnullabletable_indexIndex of the table this column belongs to.shortnameName of the column (see rr.table_column for more metadata).charindexednullablefill_factorAn estimate for the ratio of non-NULL values in this column to the number of rows in the table.floatnullablemin_valueThe largest value found in the column.floatnullablepercentile03An estimate for the value in the 3rd percentile of the column's distribution (for a Gaussian, roughly the lower limit of a 2σ interval).floatindexednullablemedianAn estimate for the median value (or 50th percentile) of the column's distributionfloatindexednullablepercentile97An estimate for the value in the 97th percentile of the column's distribution (for a Gaussian, roughly the upper limit of a 2σ interval).floatindexednullablemax_valueThe largest value found in the column.floatnullablerr.res_tableivoidivoidtable_indextable_index
rr.interface Information on access modes of a capability.xpath:/capability/interface/95935ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexThe index of the parent capability.shortindexedintf_indexAn arbitrary identifier for the interfaces of a resource.shortindexedprimaryintf_typeThe type of the interface (vr:webbrowser, vs:paramhttp, etc).xpath:@xsi:typecharnullableintf_roleAn identifier for the role the interface plays in the particular capability. If the value is equal to "std" or begins with "std:", then the interface refers to a standard interface defined by the standard referred to by the capability's standardID attribute.xpath:@rolecharnullablestd_versionThe version of a standard interface specification that this interface complies with. When the interface is provided in the context of a Capability element, then the standard being refered to is the one identified by the Capability's standardID element.xpath:@versioncharnullablequery_typeHash-joined list of expected HTTP method (get or post) supported by the service.xpath:queryTypecharnullableresult_typeThe MIME type of a document returned in the HTTP response.xpath:resultTypecharnullablewsdl_urlThe location of the WSDL that describes this Web Service. If NULL, the location can be assumed to be the accessURL with '?wsdl' appended.xpath:wsdlURLcharnullableurl_useA flag indicating whether this should be interpreted as a base URL ('base'), a full URL ('full'), or a URL to a directory that will produce a listing of files ('dir').xpath:accessURL/@usecharnullableaccess_urlThe URL at which the interface is found.xpath:accessURLcharnullablemirror_urlSecondary access URLs of this interface, separated by hash characters.xpath:mirrorURLcharnullableauthenticated_onlyA flag for whether an interface is available for anonymous use (=0) or only authenticated clients are served (=1).shortsecurity_method_idThis column was mentioned in drafts of RegTAP 1.1 but was abandoned before RegTAP 1.1 REC. Do not use any more. This is just here to avoid a flag day for clients that experimentally used this column. This is always NULL here.not mappedcharnullablerr.capabilityivoidivoidcap_indexcap_index
rr.intf_param Input parameters for services.xpath:/capability/interface/param/3178ivoidThe parent resource.xpath:/identifiercharindexednullableintf_indexThe index of the interface this parameter belongs to.shortnameThe name of the parameter.xpath:namecharnullableucdA unified content descriptor that describes the scientific content of the parameter.xpath:ucdcharnullableunitThe unit associated with all values in the parameter.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this parameter represents.xpath:utypecharnullablestdIf 1, the meaning and use of this parameter is reserved and defined by a standard model. If 0, it represents a database-specific parameter that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the parameter.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this parameter contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullableparam_useAn indication of whether this parameter is required to be provided for the application or service to work properly (one of required, optional, ignored, or NULL).xpath:@usecharnullableparam_descriptionA free-text description of the parameter's contents.xpath:descriptionunicodeCharnullablerr.interfaceivoidivoidintf_indexintf_index
rr.registries Administrative table: publishing registries we harvest, together with +the dates of last full and incremental harvests.ivo://ivoa.net/std/RegTAP#1.153ivoidIVOID of the registry.charindexedprimaryaccessurlURL of the registry's OAI-PMH endpoint.charnullabletitleName of the registry.unicodeCharnullablelast_full_harvestDate and time of the last full harvest of the registry.charnullablelast_inc_harvestDate and time of the last incremental harvest of the registry.charnullable
rr.relationship Relationships between resources (like mirroring, derivation, serving +a data collection).xpath:/content/relationship/23702ivoidThe parent resource.xpath:/identifiercharindexednullablerelationship_typeThe type of the relationship; these terms are drawn from a controlled vocabulary and are DataCite-compatible.xpath:relationshipTypecharnullablerelated_idThe IVOA identifier for the resource referred to.xpath:relatedResource/@ivo-idcharnullablerelated_nameThe name of resource that this resource is related to.xpath:relatedResourcecharnullablerr.resourceivoidivoid
rr.res_date A date associated with an event in the life cycle of the resource. +This could be creation or update. The role column can be used to +clarify.xpath:/curation/23363ivoidThe parent resource.xpath:/identifiercharindexednullabledate_valueA date associated with an event in the life cycle of the resource.xpath:datecharnullablevalue_roleA string indicating what the date refers to, e.g., created, availability, updated. This value is generally drawn from a controlled vocabulary.xpath:date/@rolecharnullablerr.resourceivoidivoid
rr.res_detail XPath-value pairs for members of resource or capability and their derivations that are less used and/or from VOResource extensions. The pairs refer to a resource if cap_index is NULL, to the referenced -capability otherwise.ivo://ivoa.net/std/RegTAP#1.1215590ivoidThe parent resource.xpath:/identifiercharindexednullablecap_indexThe index of the parent capability; if NULL the xpath-value pair describes a member of the entire resource.shortnullabledetail_xpathThe xpath of the data item.charnullabledetail_value(Atomic) value of the member.unicodeCharnullablerr.resourceivoidivoid
rr.interface Information on access modes of a capability.xpath:/capability/interface/95935ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexThe index of the parent capability.shortindexedintf_indexAn arbitrary identifier for the interfaces of a resource.shortindexedprimaryintf_typeThe type of the interface (vr:webbrowser, vs:paramhttp, etc).xpath:@xsi:typecharnullableintf_roleAn identifier for the role the interface plays in the particular capability. If the value is equal to "std" or begins with "std:", then the interface refers to a standard interface defined by the standard referred to by the capability's standardID attribute.xpath:@rolecharnullablestd_versionThe version of a standard interface specification that this interface complies with. When the interface is provided in the context of a Capability element, then the standard being refered to is the one identified by the Capability's standardID element.xpath:@versioncharnullablequery_typeHash-joined list of expected HTTP method (get or post) supported by the service.xpath:queryTypecharnullableresult_typeThe MIME type of a document returned in the HTTP response.xpath:resultTypecharnullablewsdl_urlThe location of the WSDL that describes this Web Service. If NULL, the location can be assumed to be the accessURL with '?wsdl' appended.xpath:wsdlURLcharnullableurl_useA flag indicating whether this should be interpreted as a base URL ('base'), a full URL ('full'), or a URL to a directory that will produce a listing of files ('dir').xpath:accessURL/@usecharnullableaccess_urlThe URL at which the interface is found.xpath:accessURLcharnullablemirror_urlSecondary access URLs of this interface, separated by hash characters.xpath:mirrorURLcharnullableauthenticated_onlyA flag for whether an interface is available for anonymous use (=0) or only authenticated clients are served (=1).shortsecurity_method_idThis column was mentioned in drafts of RegTAP 1.1 but was abandoned before RegTAP 1.1 REC. Do not use any more. This is just here to avoid a flag day for clients that experimentally used this column. This is always NULL here.not mappedcharnullablerr.capabilityivoidivoidcap_indexcap_index
rr.relationship Relationships between resources (like mirroring, derivation, serving -a data collection).xpath:/content/relationship/23702ivoidThe parent resource.xpath:/identifiercharindexednullablerelationship_typeThe type of the relationship; these terms are drawn from a controlled vocabulary and are DataCite-compatible.xpath:relationshipTypecharnullablerelated_idThe IVOA identifier for the resource referred to.xpath:relatedResource/@ivo-idcharnullablerelated_nameThe name of resource that this resource is related to.xpath:relatedResourcecharnullablerr.resourceivoidivoid
rr.intf_param Input parameters for services.xpath:/capability/interface/param/3178ivoidThe parent resource.xpath:/identifiercharindexednullableintf_indexThe index of the interface this parameter belongs to.shortnameThe name of the parameter.xpath:namecharnullableucdA unified content descriptor that describes the scientific content of the parameter.xpath:ucdcharnullableunitThe unit associated with all values in the parameter.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this parameter represents.xpath:utypecharnullablestdIf 1, the meaning and use of this parameter is reserved and defined by a standard model. If 0, it represents a database-specific parameter that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the parameter.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this parameter contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullableparam_useAn indication of whether this parameter is required to be provided for the application or service to work properly (one of required, optional, ignored, or NULL).xpath:@usecharnullableparam_descriptionA free-text description of the parameter's contents.xpath:descriptionunicodeCharnullablerr.interfaceivoidivoidintf_indexintf_index
rr.validationValidation levels for resources and capabilities.xpath:/(capability/|)validationLevel23685ivoidThe parent resource.xpath:/identifiercharindexednullablevalidated_byThe IVOA ID of the registry or organisation that assigned the validation level.xpath:validationLevel/@validatedBycharnullableval_levelA numeric grade describing the quality of the resource description, when applicable, to be used to indicate the confidence an end-user can put in the resource as part of a VO application or research study.xpath:validationLevelshortnullablecap_indexIf non-NULL, the validation only refers to the capability referenced here.shortnullablerr.resourceivoidivoidrr.resourceivoidivoid
rr.res_date A date associated with an event in the life cycle of the resource. -This could be creation or update. The role column can be used to -clarify.xpath:/curation/23363ivoidThe parent resource.xpath:/identifiercharindexednullabledate_valueA date associated with an event in the life cycle of the resource.xpath:datecharnullablevalue_roleA string indicating what the date refers to, e.g., created, availability, updated. This value is generally drawn from a controlled vocabulary.xpath:date/@rolecharnullablerr.resourceivoidivoid
rr.alt_identifier An alternate identifier associated with this record. This can be a -resiource identifier like a DOI (in URI form, e.g., -doi:10.1016/j.epsl.2011.11.037), or a person identifier of a creator -(typically an ORCID in URI form, e.g., orcid:000-0000-0000-000X).xpath:/(curation/creator/|)altIdentifier63ivoidThe parent resource.xpath:/identifiercharindexednullablealt_identifierAn identifier for the resource or an entity related to the resource in URI form.charindexednullablerr.resourceivoidivoid
rr.stc_spatial The spatial coverage of resources. This table associates footprints +capability otherwise.ivo://ivoa.net/std/RegTAP#1.1215590ivoidThe parent resource.xpath:/identifiercharindexednullablecap_indexThe index of the parent capability; if NULL the xpath-value pair describes a member of the entire resource.shortnullabledetail_xpathThe xpath of the data item.charnullabledetail_value(Atomic) value of the member.unicodeCharnullablerr.resourceivoidivoid
rr.res_role Entities (persons or organizations) operating on resources: creators, +contacts, publishers, contributors.ivo://ivoa.net/std/RegTAP#1.195827ivoidThe parent resource.xpath:/identifiercharindexednullablerole_nameThe real-world name or title of a person or organization.unicodeCharindexednullablerole_ivoidAn IVOA identifier of a person or organization.charnullablestreet_addressA mailing address for a person or organization.unicodeCharnullableemailAn email address the entity can be reached at.charnullabletelephoneA telephone number the entity can be reached at.charnullablelogoURL pointing to a graphical logo, which may be used to help identify the entity.charnullablebase_roleThe role played by this entity; this is one of contact, publisher, contributor, or creator.charindexednullablerr.resourceivoidivoid
rr.res_schema Sets of tables related to resources.xpath:/tableset/schema/2137ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexAn arbitrary identifier for the res_schema rows belonging to a resource.shortindexedprimaryschema_descriptionA free text description of the tableset explaining in general how all of the tables are related.xpath:descriptionunicodeCharnullableschema_nameA name for the set of tables.xpath:name charnullableschema_titleA descriptive, human-interpretable name for the table set.xpath:titleunicodeCharnullableschema_utypeAn identifier for a concept in a data model that the data in this schema as a whole represent.xpath:utypecharnullablerr.resourceivoidivoid
rr.res_subject Topics, object types, or other descriptive keywords about the +resource.xpath:/content/55057ivoidThe parent resource.xpath:/identifiercharindexednullableres_subjectTopics, object types, or other descriptive keywords about the resource.xpath:subjectcharindexednullablerr.resourceivoidivoid
rr.res_table (Relational) tables that are part of schemata or resources.xpath:/(tableset/schema/|)table/60176ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexIndex of the schema this table belongs to, if it belongs to a schema (otherwise NULL).shortnullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharnullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharnullabletable_indexAn arbitrary identifier for the tables belonging to a resource.shortindexedprimarytable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharnullabletable_typeA name for the role this table plays. Recognized values include "output", indicating this table is output from a query; "base_table", indicating a table whose records represent the main subjects of its schema; and "view", indicating that the table represents a useful combination or subset of other tables. Other values are allowed.xpath:@typecharnullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullablenrowsAn estimate for the number of rows in the table.xpath:nrowslongnullablerr.resourceivoidivoid
rr.resource The resources (like services, data collections, organizations) +present in this registry.xpath:/24138ivoidUnambiguous reference to the resource conforming to the IVOA standard for identifiers.xpath:identifiercharindexedprimaryres_typeResource type (something like vg:authority, vs:catalogservice, etc).xpath:@xsi:typecharnullablecreatedThe UTC date and time this resource metadata description was created.xpath:@createdcharnullableshort_nameA short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).xpath:shortNamecharindexednullableres_titleThe full name given to the resource.xpath:titleunicodeCharindexednullableupdatedThe UTC date this resource metadata description was last updated.xpath:@updatedcharnullablecontent_levelA hash-separated list of content levels specifying the intended audience.xpath:content/contentLevelcharnullableres_descriptionAn account of the nature of the resource.xpath:content/descriptionunicodeCharindexednullablereference_urlURL pointing to a human-readable document describing this resource.xpath:content/referenceURLcharnullablecreator_seqThe creator(s) of the resource in the order given by the resource record author, separated by semicolons.xpath:curation/creator/nameunicodeCharindexednullablecontent_typeA hash-separated list of natures or genres of the content of the resource.xpath:content/typecharnullablesource_formatThe format of source_value. This, in particular, can be ``bibcode''.xpath:content/source/@formatcharnullablesource_valueA bibliographic reference from which the present resource is derived or extracted.xpath:content/sourceunicodeCharnullableres_versionLabel associated with creation or availablilty of a version of a resource.xpath:curation/versioncharnullableregion_of_regardA single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.degxpath:coverage/regionOfRegardfloatnullablewavebandA hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.xpath:coverage/wavebandcharnullablerightsA statement of usage conditions (license, attribution, embargo, etc).xpath:/rightscharnullablerights_uriA URI identifying a license the data is made available under.xpath:/rights/@rightsURIcharnullableharvested_fromIVOID of the registry this record came from.charnullablerr.registriesharvested_fromivoid
rr.stc_spatial The spatial coverage of resources. This table associates footprints (ADQL geometries) with ivoids. The footprints are intended for resource discovery; a reasonable expectation for the resolution thus -is something like a degree.xpath:/coverage/spatial16828ivoidThe parent resource.xpath:/identifiercharindexednullablecoverageA geometry representing the area a resource contains data for; this should be tight at least with a resolution of degrees.posxpath:.charnullableref_system_nameThe reference frame coverage is written in. This is currently reserved and fixed to NULL. Clients should always add a constraint to NULL for this to avoid matching non-celestial resources later.pos.framexpath:@framecharnullablerr.resourceivoidivoid
rr.stc_temporal The temporal coverage of resources, given as one or more intervals. +is something like a degree.xpath:/coverage/spatial16828ivoidThe parent resource.xpath:/identifiercharindexednullablecoverageA geometry representing the area a resource contains data for; this should be tight at least with a resolution of degrees.posxpath:.charnullableref_system_nameThe reference frame coverage is written in. This is currently reserved and fixed to NULL. Clients should always add a constraint to NULL for this to avoid matching non-celestial resources later.pos.framexpath:@framecharnullablerr.resourceivoidivoid
rr.stc_spectral The spectral coverage of resources, given as one or more intervals. The total coverage is (a subset of) the union of all intervals given -for a resource. All times are understood as MJD for TDB at the solar -system barycenter.xpath:/coverage/temporal104ivoidThe parent resource.xpath:/identifiercharindexednullabletime_startLower limit of a time interval covered by the resource.dxpath:.floattime_endUpper limit of a time interval covered by the resource.dxpath:.floatrr.resourceivoidivoid
rr.stc_spectral The spectral coverage of resources, given as one or more intervals. +for a resource. The spectral values are given as messenger energy.xpath:/coverage/spectral89ivoidThe parent resource.xpath:/identifiercharindexednullablespectral_startLower limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatspectral_endUpper limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatrr.resourceivoidivoid
rr.stc_temporal The temporal coverage of resources, given as one or more intervals. The total coverage is (a subset of) the union of all intervals given -for a resource. The spectral values are given as messenger energy.xpath:/coverage/spectral89ivoidThe parent resource.xpath:/identifiercharindexednullablespectral_startLower limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatspectral_endUpper limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatrr.resourceivoidivoid
rr.tap_table TAP-queriable tables.ivo://ivoa.net/std/RegTAP#1.1residIVOA identifier of the resource this table was taken from (where there is a dedicated resource containing this table in its tableset, that resource is preferred over a TAP service).charindexednullablesvcidIVOA identifier of the TAP service making this table queriable.charindexednullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharindexednullabletable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharindexednullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharindexednullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullable
sasmiralaSasmirala: Subarcsecond mid-infrared atlas of local AGN The Subarcsecond mid-infrared (MIR) atlas of local active galactic +for a resource. All times are understood as MJD for TDB at the solar +system barycenter.xpath:/coverage/temporal104ivoidThe parent resource.xpath:/identifiercharindexednullabletime_startLower limit of a time interval covered by the resource.dxpath:.floattime_endUpper limit of a time interval covered by the resource.dxpath:.floatrr.resourceivoidivoidrr.subject_uat res_subject mapped to the UAT. This is based on a manual mapping of +keywords found in 2020, where subjects not mappable were dropped. This +is a non-standard, local extension. Don't base your procedures on it, +we will tear it down once there is sufficient takeup of the UAT in the +VO.ivo://ivoa.net/std/RegTAP#1.151571ivoidThe parent resource.xpath:/identifiercharindexednullableuat_conceptTerm from http://www.ivoa.net/rdf/uat; most of these resulted from mapping non-UAT designations.charindexednullablerr.resourceivoidivoid
rr.table_column Metadata on columns of a resource's tables.xpath:/(tableset/schema/|)/table/column/1300000ivoidThe parent resource.xpath:/identifiercharindexednullabletable_indexIndex of the table this column belongs to.shortnameThe name of the column.xpath:namecharindexednullableucdA unified content descriptor that describes the scientific content of the column.xpath:ucdcharindexednullableunitThe unit associated with all values in the column.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this column represents.xpath:utypecharnullablestdIf 1, the meaning and use of this column is reserved and defined by a standard model. If 0, it represents a database-specific column that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the column.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this column contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullabletype_systemThe type system used, as a QName with a canonical prefix; this will ususally be one of vs:simpledatatype, vs:votabletype, and vs:taptype.xpath:dataType/@xsi:typecharnullableflagHash-separated keywords representing traits of the column. Recognized values include "indexed", "primary", and "nullable".xpath:flagcharnullablecolumn_descriptionA free-text description of the column's contents.xpath:descriptionunicodeCharindexednullablerr.res_tableivoidivoidtable_indextable_index
rr.tap_table TAP-queriable tables.ivo://ivoa.net/std/RegTAP#1.1residIVOA identifier of the resource this table was taken from (where there is a dedicated resource containing this table in its tableset, that resource is preferred over a TAP service).charindexednullablesvcidIVOA identifier of the TAP service making this table queriable.charindexednullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharindexednullabletable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharindexednullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharindexednullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullable
rr.validationValidation levels for resources and capabilities.xpath:/(capability/|)validationLevel23685ivoidThe parent resource.xpath:/identifiercharindexednullablevalidated_byThe IVOA ID of the registry or organisation that assigned the validation level.xpath:validationLevel/@validatedBycharnullableval_levelA numeric grade describing the quality of the resource description, when applicable, to be used to indicate the confidence an end-user can put in the resource as part of a VO application or research study.xpath:validationLevelshortnullablecap_indexIf non-NULL, the validation only refers to the capability referenced here.shortnullablerr.resourceivoidivoidrr.resourceivoidivoid
sasmiralaSasmirala: Subarcsecond mid-infrared atlas of local AGN The Subarcsecond mid-infrared (MIR) atlas of local active galactic nuclei (AGN) is a collection of all available N- and Q-band images obtained at ground-based 8-meter class telescopes with public archives (Gemini/Michelle, Gemini/T-ReCS, Subaru/COMICS, and VLT/VISIR). It @@ -1584,9 +1591,9 @@ multi-epoch data which are merged into a single source catalogue for general science exploitation. Within the GAVO DC, some column names have been adapted to local customs (primarily positions, proper motions).1900000000objidSuperCOSMOS identifier of merged sourcemeta.id;meta.mainlongobjidbobjID for B band detection merged into this objectmeta.id.assoclongnullableobjidr1objID for R1 band detection merged into this objectmeta.id.assoclongnullableobjidr2objID for R2 band detection merged into this objectmeta.id.assoclongnullableobjidiobjID for I band detection merged into this objectmeta.id.assoclongnullableepochEpoch of position (variance weighted mean epoch of available measures)yrtime.epochfloatnullableraj2000Mean RA, computed from detections merged in this cataloguedegpos.eq.ra;meta.maindoubleindexednullabledej2000Mean Dec, computed from detections merged in this cataloguedegpos.eq.dec;meta.maindoubleindexednullablesigraUncertainty in RA (formal random error not including systematic errors)degstat.error;pos.eq.rafloatnullablesigdecUncertainty in Dec (formal random error not including systematic errors)degstat.error;pos.eq.rafloatnullablepmraProper motion in RA directiondeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Dec directiondeg/yrpos.pm;pos.eq.decfloatnullablee_pmraError on proper motion in RA directiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeError on proper motion in Dec directiondeg/yrstat.error;pos.pm;pos.eq.decfloatnullablechi2Chi-squared value of proper motion solutionstat.fit.chi2floatnullablenplatesNo. of plates used for this proper motion measurementmeta.number;obsshortclassmagbB band magnitude selected by B image classmagphot.mag;em.opt.Bfloatindexednullableclassmagr1R1 band magnitude selected by R1 image classmagphot.mag;em.opt.Rfloatnullableclassmagr2R2 band magnitude selected by R2 image classmagphot.mag;em.opt.RfloatnullableclassmagiI band magnitude selected by I image classmagphot.mag;em.opt.IfloatindexednullablegcormagbB band magnitude assuming object is galaxymagphot.mag;em.opt.Bfloatnullablegcormagr1R1 band magnitude assuming object is galaxymagphot.mag;em.opt.Rfloatnullablegcormagr2R2 band magnitude assuming object is galaxymagphot.mag;em.opt.RfloatnullablegcormagiI band magnitude assuming object is galaxymagphot.mag;em.opt.IfloatnullablescormagbB band magnitude assuming object is starmagphot.mag;em.opt.Bfloatnullablescormagr1R1 band magnitude assuming object is starmagphot.mag;em.opt.Rfloatnullablescormagr2R2 band magnitude assuming object is starmagphot.mag;em.opt.RfloatnullablescormagiI band magnitude assuming object is starmagphot.mag;em.opt.IfloatnullablemeanclassEstimate of image class based on unit-weighted mean of individual classessrc.class.starGalaxyshortclassbImage classification from B band detectionsrc.class;em.opt.Bshortnullableclassr1Image classification from R1 band detectionsrc.class;em.opt.Rshortnullableclassr2Image classification from R2 band detectionsrc.class;em.opt.RshortnullableclassiImage classification from I band detectionsrc.class;em.opt.IshortnullableellipbEllipticity of B band detectionsrc.ellipticityfloatnullableellipr1Ellipticity of R1 band detectionsrc.ellipticity;em.opt.Rfloatnullableellipr2Ellipticity of R2 band detectionsrc.ellipticity;em.opt.RfloatnullableellipiEllipticity of I band detectionsrc.ellipticity;em.opt.IfloatnullablequalbBitwise quality flag from B band detectionmeta.code.qual;em.opt.Bintnullablequalr1Bitwise quality flag from R1 band detectionmeta.code.qual;em.opt.Rintnullablequalr2Bitwise quality flag from R2 band detectionmeta.code.qual;em.opt.RintnullablequaliBitwise quality flag from I band detectionmeta.code.qual;em.opt.IintnullableblendbBlend flag from B band detectionmeta.code.qual;em.opt.Bintnullableblendr1Blend flag from R1 band detectionmeta.code.qual;em.opt.Rintnullableblendr2Blend flag from R2 band detectionmeta.code.qual;em.opt.RintnullableblendiBlend flag from I band detectionmeta.code.qual;em.opt.IintnullableprfstatbProfile statistic from B band detectionsrc.class.starGalaxyfloatnullableprfstatr1Profile statistic from R1 band detectionsrc.class.starGalaxy;em.opt.Rfloatnullableprfstatr2Profile statistic from R2 band detectionsrc.class.starGalaxy;em.opt.RfloatnullableprfstatiProfile statistic from I band detectionsrc.class.starGalaxy;em.opt.RfloatnullableebmvThe estimated foreground reddening at this position from Schlegel et al. (1998)magphys.absorptionfloatnullabletap_schema GAVO Data Center's Table Access Protocol (TAP) service with -table metadata.tap_schema.schemasSchemas containing tables available for ADQL querying.schema_nameFully qualified schema namecharindexedprimarydescriptionBrief description of the schemaunicodeCharnullableutypeutype if schema corresponds to a data modelcharnullableschema_indexSuggested position this schema should take in a sorted list of schemas from this data center.intnullable
tap_schema.tablesTables available for ADQL querying.schema_nameFully qualified schema namecharnullabletable_nameFully qualified table namecharindexedprimarytable_typeOne of: table, viewcharnullabledescriptionBrief description of the tableunicodeCharnullableutypeutype if the table corresponds to a data modelcharnullabletable_indexSuggested position this table should take in a sorted list of tables from this data centerintnullablesourcerdId of the originating rd (local information)charnullablenrowsThe approximate size of the table in rowslongnullabletap_schema.schemasschema_nameschema_name
tap_schema.columnsColumns in tables available for ADQL querying.table_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columnunicodeCharnullableunitUnit in VO standard formatcharnullableucdUCD of column if anycharnullableutypeUtype of column if anycharnullabledatatypeADQL datatypecharnullablearraysizeArraysize in VOTable notationcharnullablextypeVOTable extended type information (for special interpretation of data content, e.g., timestamps or points)charnullable"size"Legacy length (ignore if you can).intnullableprincipalIs column principal?intindexedIs there an index on this column?intstdIs this a standard column?intsourcerdId of the originating rd (local information)charnullablecolumn_index1-based index of the column in database order.shortnullabletap_schema.tablestable_nametable_name
tap_schema.keysForeign key relationships between tables available for ADQL querying.key_idUnique key identifiercharindexedprimaryfrom_tableFully qualified table namecharnullabletarget_tableFully qualified table namecharnullabledescriptionDescription of this keyunicodeCharnullableutypeUtype of this keycharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablesfrom_tabletable_nametap_schema.tablestarget_tabletable_name
tap_schema.key_columnsColumns participating in foreign key relationships between tables -available for ADQL querying.key_idKey identifier from TAP_SCHEMA.keyscharnullablefrom_columnKey column name in the from tablecharnullabletarget_columnKey column in the target tablecharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.keyskey_idkey_id
tap_schema.groupsColumns that are part of groups within tables available for ADQL -querying.table_nameFully qualified table namecharnullablecolumn_nameName of a column belonging to the groupcharnullablecolumn_utypeutype the column within the groupcharnullablegroup_nameName of the groupcharnullablegroup_utypeutype of the groupcharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablestable_nametable_name
taptestData for regression teststaptest.mainA table containing nonsensical data. Do not use except for +table metadata.
tap_schema.columnsColumns in tables available for ADQL querying.table_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columnunicodeCharnullableunitUnit in VO standard formatcharnullableucdUCD of column if anycharnullableutypeUtype of column if anycharnullabledatatypeADQL datatypecharnullablearraysizeArraysize in VOTable notationcharnullablextypeVOTable extended type information (for special interpretation of data content, e.g., timestamps or points)charnullable"size"Legacy length (ignore if you can).intnullableprincipalIs column principal?intindexedIs there an index on this column?intstdIs this a standard column?intsourcerdId of the originating rd (local information)charnullablecolumn_index1-based index of the column in database order.shortnullabletap_schema.tablestable_nametable_name
tap_schema.groupsColumns that are part of groups within tables available for ADQL +querying.table_nameFully qualified table namecharnullablecolumn_nameName of a column belonging to the groupcharnullablecolumn_utypeutype the column within the groupcharnullablegroup_nameName of the groupcharnullablegroup_utypeutype of the groupcharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablestable_nametable_name
tap_schema.key_columnsColumns participating in foreign key relationships between tables +available for ADQL querying.key_idKey identifier from TAP_SCHEMA.keyscharnullablefrom_columnKey column name in the from tablecharnullabletarget_columnKey column in the target tablecharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.keyskey_idkey_id
tap_schema.keysForeign key relationships between tables available for ADQL querying.key_idUnique key identifiercharindexedprimaryfrom_tableFully qualified table namecharnullabletarget_tableFully qualified table namecharnullabledescriptionDescription of this keyunicodeCharnullableutypeUtype of this keycharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablesfrom_tabletable_nametap_schema.tablestarget_tabletable_name
tap_schema.schemasSchemas containing tables available for ADQL querying.schema_nameFully qualified schema namecharindexedprimarydescriptionBrief description of the schemaunicodeCharnullableutypeutype if schema corresponds to a data modelcharnullableschema_indexSuggested position this schema should take in a sorted list of schemas from this data center.intnullable
tap_schema.tablesTables available for ADQL querying.schema_nameFully qualified schema namecharnullabletable_nameFully qualified table namecharindexedprimarytable_typeOne of: table, viewcharnullabledescriptionBrief description of the tableunicodeCharnullableutypeutype if the table corresponds to a data modelcharnullabletable_indexSuggested position this table should take in a sorted list of tables from this data centerintnullablesourcerdId of the originating rd (local information)charnullablenrowsThe approximate size of the table in rowslongnullabletap_schema.schemasschema_nameschema_name
taptestData for regression teststaptest.mainA table containing nonsensical data. Do not use except for experiments.radegpos.eq.ra;meta.mainfloatindexednullablededegpos.eq.dec;meta.mainfloatindexednullablespectralinstr.bandpasscharnullable
tenpcThe 10 parsec sample in the Gaia era A catalogue of 541 nearby (within 10pc of the sun) stars, brown dwarfs, and confirmed exoplanets in 336 systems, as well 21 candidates, compiled from SIMBAD and several other sources. Where @@ -1627,12 +1634,12 @@ TAP service.480000000nobNumber of objects the correction is based onmeta.numberintalphaCenter for field, RAdegpos.eq.ra;meta.mainfloatindexednullabledeltaCenter for field, Decdegpos.eq.dec;meta.mainfloatindexednullabled_alphaCorrection PPMXL-UCAC3 in alpha (Epoch 2000.0)degpos.eq.ra;arith.difffloatnullabled_deltaCorrection PPMXL-UCAC3 in delta (Epoch 2000.0)degpos.eq.dec;arith.difffloatnullabled_pmalphaCorrection PPMXL-UCAC3 in proper motion alpha*cos(delta)deg/yrpos.pm;pos.eq.ra;arith.difffloatnullabled_pmdeltaCorrection PPMXL-UCAC3 in deltadeg/yrpos.pm;pos.eq.dec;arith.difffloatnullableucac3.mainThe UCAC3 all-sky CCD astrograph catalogue, minus the fields from 2MASS and SuperCosmos and matching/object flags (which can be recovered with a local crossmatch).110000000raj2000Right ascension at epoch (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at epoch (ICRS)degpos.eq.dec;meta.maindoubleindexednullablemmagUCAC fit model magnitudemagphot.mag;em.optfloatnullablemaperUCAC aperture magnitudemagphot.mag;em.optfloatnullablesigmagUCAC error on magnitude (larger of obs. scatter and model error)magstat.error;phot.mag;em.optfloatnullableobjtObject typesrc.classcharnullabledsfDouble star flagmeta.codecharnullablesigras.e. at central epoch in RA (*cos Dec)degstat.error;pos.eq.rafloatnullablesigdcs.e. at central epoch in Decdegstat.error;pos.eq.decfloatnullablena1Total number of CCD images of this starmeta.numbershortnu1Number of CCD images used for this starmeta.number;stat.fitshortus1Number of catalogs/epochs used for proper motionsmeta.numbershortcn1Number of catalogs/epochs in initial matchmeta.numbershortcepraCentral epoch for mean RAtime.epochcharnullablecepdcCentral epoch for mean Declinationtime.epochcharnullablepmraProper motion in RA, cos(Dec) applieddeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablesigpmraError in proper motion in RA, cos(Dec) applieddeg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
ucac3.ppmxlcrossA crossmatch between UCAC3 and PPMXL, created solely based on -positions with a window of 1.5 arcsec radius.99000000ucac3idipix of UCAC3 objectmeta.idlongindexedppmxlidPPMXL ipixmeta.id;meta.mainlongindexed
ucac3.icrscorrCorrections between UCAC3 and the ICRS as represented by PPMXL on a -grid of degrees, obtained by substracting UCAC3 from PPMXL in cones of -radius sqrt(2)/2 degrees around the given center position.65294nobNumber of objects the correction is based onmeta.numberintalphaCenter for field, RAdegpos.eq.ra;meta.mainfloatindexednullabledeltaCenter for field, Decdegpos.eq.dec;meta.mainfloatindexednullabled_alphaCorrection PPMXL-UCAC3 in alpha (Epoch 2000.0)degpos.eq.ra;arith.difffloatnullabled_deltaCorrection PPMXL-UCAC3 in delta (Epoch 2000.0)degpos.eq.dec;arith.difffloatnullabled_pmalphaCorrection PPMXL-UCAC3 in proper motion alpha*cos(delta)deg/yrpos.pm;pos.eq.ra;arith.difffloatnullabled_pmdeltaCorrection PPMXL-UCAC3 in deltadeg/yrpos.pm;pos.eq.dec;arith.difffloatnullable
ucac4The fourth U.S. Naval Observatory CCD Astrograph Catalog (UCAC4) UCAC4 is a compiled, all-sky star catalog covering mainly the 8 to 16 +positions with a window of 1.5 arcsec radius.99000000ucac3idipix of UCAC3 objectmeta.idlongindexedppmxlidPPMXL ipixmeta.id;meta.mainlongindexeducac4The fourth U.S. Naval Observatory CCD Astrograph Catalog (UCAC4) UCAC4 is a compiled, all-sky star catalog covering mainly the 8 to 16 magnitude range in a single bandpass between V and R. Positional errors are about 15 to 20 mas for stars in the 10 to 14 mag range. Proper motions have been derived for most of the about 113 @@ -1701,12 +1708,10 @@ hemisphere and some areas down to -24.8° in declination. In the GAVO data center, we left out all columns originating from cross matches with other catalogs; on-the fly crossmatches can be done -in our TAP service.230000000idURAT1 recommended identifier (ZZZ-NNNNNN)meta.id;meta.maincharindexedprimaryraj2000Right ascension on ICRS, at Epochdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination on ICRS, at Epochdegpos.eq.dec;meta.maindoubleindexednullablepos_err_scatterPosition error per coordinate, from scatterdegstat.error;posfloatnullablepos_err_modelPosition error per coordinate, from modeldegstat.error;posfloatnullableepochMean URAT observation epochyrtime.epochfloatnullablemagMean URAT model fit magnitude (between R and I)magphot.mag;em.opt.Rfloatindexednullablee_magError in URAT model fit magnitude, derived from the scatter of individual observations, plus a floor of 0.01.magstat.error;phot.mag;em.opt.Rfloatnullablen_setsTotal number of images (observations)meta.number;obsshortn_sets_posNumber of sets used for mean positionmeta.number;obsshortn_sets_magNumber of sets used for URAT magnitudemeta.number;obsshortrefstarLargest reference star flagmeta.code.qualcharn_imTotal number of images (observations)meta.number;obsshortn_im_usedNumber of images used for mean positionmeta.number;obsshortn_gratingTotal number of 1st order grating observationsmeta.number;obsshortn_grating_usedNumber of 1st order grating positions usedmeta.number;obsshortusnobPlate data for the USNO-B 1.0 Catalogue. This table contains the metadata for the plates that went into USNO-B -1.0 as best as we can reconstruct it (i.e., largely those that also -make up the Digital Sky Survey DSS). Most of the source files were -obtained from http://www.nofs.navy.mil/data/fchpix/, some additional -contributions came from Dave Monet.usnob.dataThe USNO-B 1.0 catalogue with Barron's spurious detections removed.1100000000raj2000Right Ascension at Eq=J2000, Ep=J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at Eq=J2000, Ep=J2000degpos.eq.dec;meta.maindoubleindexednullablee_radegMean error on RAdeg*cos(DEdeg) at Epochdegstat.error;pos.eq.rafloatnullablee_dedegMean error on DEdeg at Epochdegstat.error;pos.eq.decfloatnullableepochMean epoch of observationyrtime.epochfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in DEdeg/yrpos.pm;pos.eq.decfloatnullablemuprTotal Proper Motion probabilitystat.fit.goodnessfloatnullablee_pmraMean error on pmRAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error on pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablefit_raMean error on RA fitdegstat.errorfloatnullablefit_deMean error on DE fitdegstat.errorfloatnullablendetNumber of detectionsmeta.numbershortflagsFlags on objectmeta.codecharnullableb1magFirst blue magnitude (B1)magphot.mag;em.opt.Bfloatnullableb1sB1 Survey codemeta.idcharindexednullableb1fB1 Field number in surveymeta.id;obs.fieldshortindexednullableb1sgB1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb1xiB1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb1etaB1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler1magFirst red magnitude (R1)magphot.mag;em.opt.Rfloatnullabler1sR1 Survey codemeta.idcharindexednullabler1fR1 Field number in surveymeta.id;obs.fieldshortindexednullabler1sgR1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler1xiR1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler1etaR1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableb2magSecond blue magnitude (B2)magphot.mag;em.opt.Bfloatnullableb2sB2 Survey codemeta.idcharindexednullableb2fB2 Field number in surveymeta.id;obs.fieldshortindexednullableb2sgB2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb2xiB2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb2etaB2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler2magSecond red magnitude (R2)magphot.mag;em.opt.Rfloatnullabler2sR2 Survey codemeta.idcharindexednullabler2fR2 Field number in surveymeta.id;obs.fieldshortindexednullabler2sgR2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler2xiR2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler2etaR2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableimagInfrared (N) magnitudemagphot.mag;em.opt.Ifloatnullablei_sI Survey codemeta.idcharindexednullableifI Field number in surveymeta.id;obs.fieldshortindexednullableisgI Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableixiI Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableietaI Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullable
usnob.spuriousSpurious detections in USNO-B 1.0 as established by Barron et al, -2008AJ....135..414B.18000000raRA of spurious detectiondegpos.eq.ra;meta.maindoubleindexednullabledecDec of spurious detectiondegpos.eq.dec;meta.maindoubleindexednullable
usnob.ppmxcrossA crossmatch between USNO-B 1.0 and PPMX.18000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedppmxidPPMX id of matching objectmeta.id;meta.maincharindexednullable
usnob.twomasscrossA crossmatch between USNO-B 1.0 and 2MASS.360000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedtwomassid2MASS id of matching objectmeta.id;meta.maincharindexednullable
usnob.platecorrsICRS Corrections by USNO-B1 PlatePlate corrections to USNO-B 1.0 based on a crossmatch with PPMX7194surveySurvey identifier, see long docsmeta.idcharfieldField number in surveymeta.id;obs.fieldshortdaMean offset in alphadegpos.eq.ra;arith.difffloatnullableddMean offset in deltadegpos.eq.dec;arith.difffloatnullablentotalNumber of objects in estimatemeta.numberint
usnob.platesPlate data for the source plates of USNO-B8855fieldField number in surveymeta.id;obs.fieldshortplatePlate number in USNO-Bmeta.id;obs.field;meta.maincharnullablesurveySurvey identifier, see long docsmeta.idcharindexedepochPlate epochyrtime.epochcharnullableemulsionEmulsioninstr.plate.emulsioncharnullablefilterFiltermeta.id;instr.filtercharnullableexposureLength of exposurestime.duration;obs.exposurefloatnullableusnocode2-char plate code given in the plate cataloguemeta.id;obs.fieldcharnullablealpha1950Field center alpha for B1950degpos.eq.rafloatnullabledelta1950Field center decl for B1950degpos.eq.decfloatnullablealpha2000Field center alpha for J2000degpos.eq.ra;meta.mainfloatindexednullabledelta2000Field center decl for J2000degpos.eq.dec;meta.mainfloatindexednullablesrcSource file for this recordmeta.ref;meta.filecharnullablealphamin1950degpos.eq.ra;stat.minfloatnullablealphamax1950degpos.eq.ra;stat.maxfloatnullabledeltamin1950degpos.eq.dec;stat.minfloatnullabledeltamax1950degpos.eq.dec;stat.maxfloatnullable
veronqsosQuasars and Active Galactic Nuclei (8th Ed.) This catalogue (with updates to the pervious version) contains 11358 +in our TAP service.230000000idURAT1 recommended identifier (ZZZ-NNNNNN)meta.id;meta.maincharindexedprimaryraj2000Right ascension on ICRS, at Epochdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination on ICRS, at Epochdegpos.eq.dec;meta.maindoubleindexednullablepos_err_scatterPosition error per coordinate, from scatterdegstat.error;posfloatnullablepos_err_modelPosition error per coordinate, from modeldegstat.error;posfloatnullableepochMean URAT observation epochyrtime.epochfloatnullablemagMean URAT model fit magnitude (between R and I)magphot.mag;em.opt.Rfloatindexednullablee_magError in URAT model fit magnitude, derived from the scatter of individual observations, plus a floor of 0.01.magstat.error;phot.mag;em.opt.Rfloatnullablen_setsTotal number of images (observations)meta.number;obsshortn_sets_posNumber of sets used for mean positionmeta.number;obsshortn_sets_magNumber of sets used for URAT magnitudemeta.number;obsshortrefstarLargest reference star flagmeta.code.qualcharn_imTotal number of images (observations)meta.number;obsshortn_im_usedNumber of images used for mean positionmeta.number;obsshortn_gratingTotal number of 1st order grating observationsmeta.number;obsshortn_grating_usedNumber of 1st order grating positions usedmeta.number;obsshortusnobThe USNO-B 1.0 CatalogThe USNO-B catalog is an all-sky catalog of about 1e9 objects +including their proper motions, based on scans of several sky surveys +conducted between 1950 and the late 1990ies.usnob.dataThe USNO-B 1.0 catalogue with Barron's spurious detections removed.1100000000raj2000Right Ascension at Eq=J2000, Ep=J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at Eq=J2000, Ep=J2000degpos.eq.dec;meta.maindoubleindexednullablee_radegMean error on RAdeg*cos(DEdeg) at Epochdegstat.error;pos.eq.rafloatnullablee_dedegMean error on DEdeg at Epochdegstat.error;pos.eq.decfloatnullableepochMean epoch of observationyrtime.epochfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in DEdeg/yrpos.pm;pos.eq.decfloatnullablemuprTotal Proper Motion probabilitystat.fit.goodnessfloatnullablee_pmraMean error on pmRAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error on pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablefit_raMean error on RA fitdegstat.errorfloatnullablefit_deMean error on DE fitdegstat.errorfloatnullablendetNumber of detectionsmeta.numbershortflagsFlags on objectmeta.codecharnullableb1magFirst blue magnitude (B1)magphot.mag;em.opt.Bfloatnullableb1sB1 Survey codemeta.idcharindexednullableb1fB1 Field number in surveymeta.id;obs.fieldshortindexednullableb1sgB1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb1xiB1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb1etaB1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler1magFirst red magnitude (R1)magphot.mag;em.opt.Rfloatnullabler1sR1 Survey codemeta.idcharindexednullabler1fR1 Field number in surveymeta.id;obs.fieldshortindexednullabler1sgR1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler1xiR1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler1etaR1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableb2magSecond blue magnitude (B2)magphot.mag;em.opt.Bfloatnullableb2sB2 Survey codemeta.idcharindexednullableb2fB2 Field number in surveymeta.id;obs.fieldshortindexednullableb2sgB2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb2xiB2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb2etaB2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler2magSecond red magnitude (R2)magphot.mag;em.opt.Rfloatnullabler2sR2 Survey codemeta.idcharindexednullabler2fR2 Field number in surveymeta.id;obs.fieldshortindexednullabler2sgR2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler2xiR2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler2etaR2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableimagInfrared (N) magnitudemagphot.mag;em.opt.Ifloatnullablei_sI Survey codemeta.idcharindexednullableifI Field number in surveymeta.id;obs.fieldshortindexednullableisgI Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableixiI Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableietaI Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullable
usnob.platecorrsICRS Corrections by USNO-B1 PlatePlate corrections to USNO-B 1.0 based on a crossmatch with PPMX7194surveySurvey identifier, see long docsmeta.idcharfieldField number in surveymeta.id;obs.fieldshortdaMean offset in alphadegpos.eq.ra;arith.difffloatnullableddMean offset in deltadegpos.eq.dec;arith.difffloatnullablentotalNumber of objects in estimatemeta.numberint
usnob.platesPlate data for the source plates of USNO-B8855fieldField number in surveymeta.id;obs.fieldshortplatePlate number in USNO-Bmeta.id;obs.field;meta.maincharnullablesurveySurvey identifier, see long docsmeta.idcharindexedepochPlate epochyrtime.epochcharnullableemulsionEmulsioninstr.plate.emulsioncharnullablefilterFiltermeta.id;instr.filtercharnullableexposureLength of exposurestime.duration;obs.exposurefloatnullableusnocode2-char plate code given in the plate cataloguemeta.id;obs.fieldcharnullablealpha1950Field center alpha for B1950degpos.eq.rafloatnullabledelta1950Field center decl for B1950degpos.eq.decfloatnullablealpha2000Field center alpha for J2000degpos.eq.ra;meta.mainfloatindexednullabledelta2000Field center decl for J2000degpos.eq.dec;meta.mainfloatindexednullablesrcSource file for this recordmeta.ref;meta.filecharnullablealphamin1950degpos.eq.ra;stat.minfloatnullablealphamax1950degpos.eq.ra;stat.maxfloatnullabledeltamin1950degpos.eq.dec;stat.minfloatnullabledeltamax1950degpos.eq.dec;stat.maxfloatnullable
usnob.ppmxcrossA crossmatch between USNO-B 1.0 and PPMX.18000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedppmxidPPMX id of matching objectmeta.id;meta.maincharindexednullable
usnob.spuriousSpurious detections in USNO-B 1.0 as established by Barron et al, +2008AJ....135..414B.18000000raRA of spurious detectiondegpos.eq.ra;meta.maindoubleindexednullabledecDec of spurious detectiondegpos.eq.dec;meta.maindoubleindexednullable
usnob.twomasscrossA crossmatch between USNO-B 1.0 and 2MASS.360000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedtwomassid2MASS id of matching objectmeta.id;meta.maincharindexednullable
veronqsosQuasars and Active Galactic Nuclei (8th Ed.) This catalogue (with updates to the pervious version) contains 11358 (+2759) quasars (defined as brighter than absolute B magnitude -23), 3334 (+501) AGNs (defined as fainter than absolute B magnitude -23) and 357 (+137) BL Lac objects from 1863 (+201) references.veronqsos.data This catalogue (with updates to the pervious version) contains 11358 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta index 23527e558af9fd80b68cb531f7c154bb07de5675..eceeef11a0baa73a20b3700f01b892e10e59d28e 100644 GIT binary patch delta 84 zcmbQvJ)L{PKZ%fxQXK^Y3kA2-Bn2Y_BNGKfBP&xgD}&8qjIxX(rrPNyMiwb%24;FG lAXx(=1B=b>Oh!xsndgtBmL_F5)K1BW@d9!-ce3y?0szis7={1< delta 84 zcmbQvJ)L{PKMCLbJRJoCQw6uwBn2Y_BNGKfV=EIAE7Q$ljIxX(#@gwYCP@}1sm6LK lAXx(=1Jlj!Oh!xs(a#Q~mL_F5)K1BW@d9!-ce3y?0sz!F7`Xrd diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 new file mode 100644 index 00000000..dcf9269f --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 @@ -0,0 +1,17 @@ + +Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. +The calib_level flag takes the following values: + +=== =========================================================== + 0 Raw Instrumental data requiring instrument-specific tools + 1 Instrumental data processable with standard tools + 2 Calibrated, science-ready data without instrument signature + 3 Enhanced data products (e.g., mosaics) +=== ===========================================================High level scientific classification of the data product, taken from an enumerationData product specific typeAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.Name of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.AAAABWltYWdlAAAAAAACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9iazEuZml0cy5negAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAywAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+SqAaWYHPGH/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAxyb3NhdC5pbWFnZXMAAAAFaW1hZ2UAAAAAAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAVgAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAxyb3NhdC5pbWFnZXMAAAAFaW1hZ2UAAAAAAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENDIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTEuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAA0AAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAT3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAA5Uk9TQVQgUFNQQ0MgUk9TQVQgTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAYAAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT4qoBpgtnu9f/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAADwAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABsAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENCIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkzLTA0LTI1IDE3OjI3OjQzLjEyOTk5NgAAAFtpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMi5maXRzLmd6AAAAAAAAAHJodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAVAAAAAAAAAABAYJtFRGOCNEAnp9uUMZwPQAERERoDt0UAAAB+UG9seWdvbiBJQ1JTIDEzMy45MzM0MTYyMTA0IDEwLjc2MzU5MDAwMTEgMTMzLjk0MTg3OTk4OTIgMTIuODkyMTI4MzMxOSAxMzEuNzU4Mjc0Mzg1IDEyLjg5MjEyODkyMiAxMzEuNzY2NzM3MDYwNyAxMC43NjM1OTA0OTEyQC4AACGN70FA5/nXSFskwkDn+ddIWyTCf8AAAH/AAAA+AcARlc79KT4qoBpgtnu9f/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQgAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ALgAAIY3vQQAAAAAAAAB/aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAxyb3NhdC5pbWFnZXMAAAAFaW1hZ2UAAAAAAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQiBST1NBVCBNZWRpdW0gWC1SYXkgMTk5My0wNC0yNSAxNzoyNzo0My4xMjk5OTYAAABbaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAAAAAAAByaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAIAAAAAAAAAAAQGCbRURjgjRAJ6fblDGcD0ABEREaA7dFAAAAflBvbHlnb24gSUNSUyAxMzMuOTMzNDE2MjEwNCAxMC43NjM1OTAwMDExIDEzMy45NDE4Nzk5ODkyIDEyLjg5MjEyODMzMTkgMTMxLjc1ODI3NDM4NSAxMi44OTIxMjg5MjIgMTMxLjc2NjczNzA2MDcgMTAuNzYzNTkwNDkxMkAuAAAhje9BQOf510hbJMJA5/nXSFskwn/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0IAAAAAAAACAAAAAAAAAAIA////////////////////////////////QC4AACGN70EAAAAAAAAAf2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWUAAAAMcm9zYXQuaW1hZ2Vz
A datalink service accompanying obscore. This will forward to data +collection-specific datalink services if they exist or return +extremely basic datalinks otherwise. \ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta new file mode 100644 index 0000000000000000000000000000000000000000..a4d3f31ff4e47602c4018418a9292af70dc5f33a GIT binary patch literal 1888 zcmaJ?OK;mo5O(WlZ8x@Sv}n-=P!9_1(4r{HZ@>q`a^ohh{BGJqu~?ELkuk|-c9)hF zz(8{;YG7~O{-Yjx>tE`uL`n7`;e|WHnc3y{eKY&}#NSubW4-52uc$d8smulOSpfRg zziK)J8UPnsEpvFAgOI`&lIOn6IT-H&74Ty!AQh2}ZlDqQQvan_-|IWArihS?gI04s zi(~L*#8S+eJKW+wK6s6*WVKfeV8Ic7oi*h~vU3hm0bS zMTJq?R01+&0siOd$;G8s<2jGDS_!4hcB|FEx8Kpw&eNz8LWH$E;B7mAs-#&}bW>l4 zpN5k?3d5OjZq@KJnVa!;&A3^UkO>^d@Svp6Jk=vpdR6bHSamz0nAoF*AVopteyhC{ob z^aexJasyg4k7YmWv>#S9AnGRtDSV33{S&p=^4*=y4SkQjjLVv{L#QCbh^CqkQ4Pf* zT@3piJ01I(1T3LZijHp!M^TC7DfVB~ij3-Uhp&pysd)V5UM-Hk6vbYRsqaQk0g^;1 zP7oU7ZgGr%cCWs8{5_*ck|_l~&K{C+CK=8ZM03)Bg75K;5QeWs;>Flx5ELgDdKG;% zj#=k{uc;KrJ_g=NKyJMB>2bN>kEXJ)GmWpsf zaYRK5%=9Df$EL)Cj9xS*_A7E|4!MRn`(|= z&k!7GQV{GqG~&p!(Z+l=cWU0}AW-bs87peSu&&kD9~x&`eKwkCYD|ZDm`nX0WkTNe z4@YE_07GYUAP*e3LBtJ|=$j@zb$3ng;7!JXCb*m=K5&yVVOriginal ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAEzIwMTUtMDctMDlUMDg6MDA6MDAAAAATMjAyMy0wNC0yMFQxMjowNjo0NQAAAAAAAAAHY2F0YWxvZwAAAAdiaWJjb2RlAAAAEwAyADAAMAAwAEkAQQBVAEMALgA3ADQAMwAyAFIALgAuAC4AMQBWf8AAAAAAAAV4LXJheQAAADRodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3Jvc2F0L3EvaW0vc2lhcC54bWw/AAAAFml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta index 77d9e295cc24d0ce6cedad9d4af86b369b3c13a3..36966ba66d0830941277fc855aa8d1400186523d 100644 GIT binary patch delta 85 zcmca8aZzHzKgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&xgD?{VW;*2_sBBt8uCPo%1W(H<@ mDIjSBBLj=g;YUm9Z02C~WCs8riW#v0 delta 85 zcmca8aZzHzKS|&GJRJoCQw6uwBn2Y_BNGKfV=EI=D+8m=;*2_sBF5V3mL^FSCaK1H mDIjSBBLmaT;YUm9Z02C~WCs8v@)_I! diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS new file mode 100644 index 00000000..fdec5b73 --- /dev/null +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS @@ -0,0 +1,28 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAALGl2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vb2JzY29yZS9vYnNjb3JlAAAAEnZzOmNhdGFsb2dyZXNvdXJjZQAAAA9HQVZPIERDIE9ic2NvcmUAAAAeAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAIABPAGIAcwBjAG8AcgBlACAAVABhAGIAbABlAAAAAAAAAGAAVABoAGUAIABJAFYATwBBAC0AZABlAGYAaQBuAGUAZAAgAG8AYgBzAGMAbwByAGUAIAB0AGEAYgBsAGUALAAgAGMAbwBuAHQAYQBpAG4AaQBuAGcAIABnAGUAbgBlAHIAaQBjACAAbQBlAHQAYQBkAGEAdABhACAAZgBvAHIACgBkAGEAdABhAHMAZQB0AHMAIAB3AGkAdABoAGkAbgAgAHQAaABpAHMAIABkAGEAdABhAGMAZQBuAHQAZQByAC4AAAA2aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YWJsZWluZm8vaXZvYS5PYnNDb3JlAAAAEABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByAAAAEzIwMTEtMDMtMjVUMTA6MjM6MDAAAAATMjAyNC0wMi0wNlQxMDoxOTozMwAAAAAAAAAAAAAAAAAAAAB/wAAAAAAAAAAAACNodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcAAAABppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eAAAAAx2czpwYXJhbWh0dHAAAAADc3RkAAAAAAAAAAA=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta new file mode 100644 index 0000000000000000000000000000000000000000..127d74d51834700125bbb9322dfa1173d3fd609d GIT binary patch literal 3250 zcmd^CUvJY^6t6~UJK9k?v`N!I>K=*;CQjnCr9t8$q$!kzq$DYfhw19ZzKKm8+uVDd zG?S3V%d|>bjOFr-7&1hLj zDnmg`-(vB%e@2ToqZZ>Lj&5@HHe^ByT}U39GUQBQt5mQ9PcTn7(iyTn$CU9e@!j|F zyEs}PLi(J=(X#2gE;FU$d*E4aa)@Nsgti5}Ym!q>^cc@E54s(%A4hAQ39dH9Et+=d z9WyKb3E~CgL&kAvXNTK+wEDE2H}tY@tjm!jB(q+zZr&*9CB2|{<}E5=(EMKVxZSbC z`|E|>^?lY|HwwnqdeL~ez4NfRwf^LJN71jCz9*R{b8;MjZ>5@nodo=f27&9CR9!58 zk{kMxc3q~O3|#Prq8lw{PK%>2Chj8x-#pf*_?x7a`nB180}mZ?|71LI;AXT$ri7~# z0r~*3apA|+L(T#UM`jXcYzqS>ZQsH@51Z{y99;>y8%MWnDT9akJZF8q4`X$o_w$kl zc`^3P*#5-6nuN_>vX}3wm|P3t;2iDa`f+saNCA};co2+VHuFV&N4MCpw5|2Gj9qJ| z08lxxV8Ek?V_4wjOM0=0SZvlEFFd)cJi1CvlLhijoL4I;W)|hO{tr%Yf8Am|7je43 z-sOsOA?3s&Wx&1e@{b)=D>tSQoTApU(1~h7^o;UZ5En_{ zBe}*fQUy*=ncjdTy1B=CG<0Rkb(oT6RfnYUm=q>OzW$5^?3qS+XFEPc0pnOKlnE7N zO3{c`Y{z1mkp{>ATprG9a4o`qnu9?ze@xxmNAPQLWv1 zWce>b#>aQ+mBy1tmAx1BJHWSIKWf+NwQ6UhP;rL7V{I5!4egMqCZW#4_PHb;9VAfl z#*uCUWC=)IHe~LE&tk&lPN3RIib5kq8Zm-&QV5eXicU%ddpiYLqBRUuLrV>C`nD9w z`?N{T%<)4GVJbnXR0JYL45=Gt7WSc<_&v0nKIMtH5goEF^^!C0scE<=`Z-5yCbZw* zFm|iWO1;*u)^JpnDUblExf{lVaXJmYwQpc0Msar3law_3JDCB;cJC|3eBz&Ag^bPVsI$lcc2XYeS)J4Ht z7$@i+j3dJPt>$w)ILACpa}rRa(m85X>RP?F-_e>!omxwK);wrvpn_1^bzDb|FQ$W& z8Shb(T}<{5doEC&6tQY~7mF0qBmzwfJ?&!%F|&9=`RZw{RRafVDcK=NsCtR!I>$^^ z5Nc1AjIoa|&QwPO$5BX>=f2++Cf2MCqm;1biu#7J4JNJ9*qgQ`ZKJfOBn<@wVPm1L z-=8{N)oU5rwS)yW6ch4lv(c#>G}=HsZ&vZUqYAou(5lu|(HBcw3N9AaZ$ZZc1)tQs z>0?A-amX-d1ef)lVyUoQ-Yt~M>a)vo#RuBsTIW@**3d+dIs|=&a+w%2MKRTil#x$b z&7(u@@oOCa7tQy4ma4&rT|ub*dI(nWigIEo$ZU!Tx^GSDC75- z!Q^df5RuM+`9L-%vlkP^ayY^&fLkQV>M&M|iJB#h4sg6mOvV+Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.
\ No newline at end of file + ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAsaXZvOi8vb3JnLmdhdm8uZGMvX19zeXN0ZW1fXy9vYnNjb3JlL29ic2NvcmUAAAAcaXZvOi8vb3JnLmdhdm8uZGMvcm9zYXQvcS9pbQAAACxpdm86Ly9vcmcuZ2F2by5kYy9fX3N5c3RlbV9fL29ic2NvcmUvb2JzY29yZQ==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta similarity index 72% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaENrXEo25y.meta rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta index 49a3bb6cdfcf3bf8ac2c026518859e3daba5f95a..fc3948d7e5b294b81f28b947c8495d8708ba1f76 100644 GIT binary patch delta 420 zcmaDLu~Cwxfo1Bli7dY)LNZEq6bvjB+)|Sij0}uS6by~5OwFteH;XaqGK!dLr<)jA zq?j3)>7{^V4U7ydCWkZaW;QdmoGi_#G})Y4UctyB)!5L?(jeKu!aOy}*ucav#Ud#s z*)%03&Cn>#(rj}X^L$3f{PRarOOrA@YNuqRctJQlEJ^t(l~bIm*%%mfbqN_WnU76l zaviHULHoc8@3IOKRJfUs&5MzsDzI@2*ky=PxS54x4gsqJ delta 401 zcmdle`9OlDfn{pwM3!F?zWI4N3I?VMZmCHMMg~SE3Wmm3CZ<*fo5dJ)8AXh>(=APs zEKE|3^-@5x21W*^lf#*IGn<-QOqOO;nrzN2uV7)BW^87hWN49?Xk=!XY@T9nX_S;? zZen7PXlas~n7Fx&c|N0K;@q|t+|0tUhmp~E@Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjMtMTAtMTdUMTI6NDI6NTQAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAABEaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAAgaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA
\ No newline at end of file +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.
Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAABEaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAAgaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA \ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta index adcdbedde14fe959e9790a9451a364d568dc5b3e..494ee1fbd666934476074d531d40fafdb7a53067 100644 GIT binary patch delta 85 zcmcaDaa&@-Kgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&xgD?{VW;*2_sBBt8uCPo%1W(H<@ mDIjSBBLj=g;YUm9Z02AMW(NQ!E*Z}N delta 85 zcmcaDaa&@-KS|&GJRJoCQw6uwBn2Y_BNGKfV=EI=D+80w;*2_sBF5V3mL^FSCaK1H mDIjSBBLmaT;YUm9Z02AMW(NQ(JQ@H1 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr index 456f3d12..5deda5d9 100644 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr @@ -19,10 +19,10 @@ WHERE AND (1 = CONTAINS(MOC(6, CIRCLE(134, 11, 0.1)), coverage)) AND (9.613059803999998e-17 BETWEEN spectral_start AND spectral_end) GROUP BY -ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta index f567e80c496cbf398adfb06244453c84cc1be4cf..6f68b78fd9e65791561c0af7fcb2097b020a62ed 100644 GIT binary patch delta 84 zcmcaEd0leCKZ%fxQXK^Y3kA2-Bn2Y_BNGKfBP&xgE5prVjJk{>rrPNyMiwb%24;FG lAXx(=1B=b!ObeL=^3ESgEltYssGX9L;sxYv=3qU~4ge7%8WR8j delta 84 zcmcaEd0leCKMCLbJRJoCQw6uwBn2Y_BNGKfV=EI=D}&8qjJk{>#@gwYCP@}1sm6LK lAXx(=1JljnObeL=5}qAMEltYssGX9L;sxYv=3qU~4geMD8bJU6 diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill index f79a88cf..f3a44423 100644 --- a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill +++ b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill @@ -4,4 +4,4 @@ JOIN tap_upload.ids AS leftids ON (ivoid=leftids.id) JOIN tap_upload.ids AS rightids ON (related_id=rightids.id) WHERE relationship_type='isservedby' - ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFw
\ No newline at end of file + ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFw
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta index 68d1f18e72a13f7c90582cd3cd96626687944a6f..78c5bdaa9da25f3f12f519114d66ad3cd5eef292 100644 GIT binary patch delta 374 zcmca9aZ_T#Kgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&yLD^s)0;*2_sBBt8uCPo%1W(H<@ zDIjSBBLj=c;Y|M(Oj0dOQj!f!jS@{wEK)7a(u@tv%@UJMO_CB5EsQOUHkUEaXLP)B z{zz(RQiezEl#CQF2&ac7DL_BR1QiezEl#CQF2&ac7DLOriginal ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjMtMTAtMTdUMTI6NDI6NTQAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD86OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vb2JzY29yZS9kbC9kbG1ldGE6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcDo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS90YWJsZU1ldGFkYXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9hdmFpbGFiaWxpdHkAAAEQaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3RhcCNhdXg6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSN0YWJsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNjYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNhdmFpbGFiaWxpdHkAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAAAAAAFWl2bzovL29yZy5nYXZvLmRjL3RhcAAAABF2czpjYXRhbG9nc2VydmljZQAAAAtHQVZPIERDIFRBUAAAABwARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAgAFQAQQBQACAAcwBlAHIAdgBpAGMAZQAAAAAAABQZAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABUAEEAUAAgAGUAbgBkACAAcABvAGkAbgB0AC4AIAAgAAoAVABoAGUAIABUAGEAYgBsAGUAIABBAGMAYwBlAHMAcwAgAFAAcgBvAHQAbwBjAG8AbAAgACgAVABBAFAAKQAgAGwAZQB0AHMAIAB5AG8AdQAgAGUAeABlAGMAdQB0AGUAIABxAHUAZQByAGkAZQBzACAAYQBnAGEAaQBuAHMAdAAgAG8AdQByAAoAZABhAHQAYQBiAGEAcwBlACAAdABhAGIAbABlAHMALAAgAGkAbgBzAHAAZQBjAHQAIAB2AGEAcgBpAG8AdQBzACAAbQBlAHQAYQBkAGEAdABhACwAIABhAG4AZAAgAHUAcABsAG8AYQBkACAAeQBvAHUAcgAgAG8AdwBuAAoAZABhAHQAYQAuACAAIAAKAAoASQBuACAARwBBAFYATwAnAHMAIABkAGEAdABhACAAYwBlAG4AdABlAHIALAAgAHcAZQAgAGkAbgAgAHAAYQByAHQAaQBjAHUAbABhAHIAIABoAG8AbABkACAAcwBlAHYAZQByAGEAbAAgAGwAYQByAGcAZQAKAGMAYQB0AGEAbABvAGcAcwAgAGwAaQBrAGUAIABQAFAATQBYAEwALAAgADIATQBBAFMAUwAgAFAAUwBDACwAIABVAFMATgBPAC0AQgAyACwAIABVAEMAQQBDADQALAAgAFcASQBTAEUALAAgAFMARABTAFMAIABEAFIAMQA2ACwACgBIAFMATwBZACwAIABhAG4AZAAgAHMAZQB2AGUAcgBhAGwAIABHAGEAaQBhACAAZABhAHQAYQAgAHIAZQBsAGUAYQBzAGUAcwAgAGEAbgBkACAAYQBuAGMAaQBsAGwAYQByAHkAIAByAGUAcwBvAHUAcgBjAGUAcwAgAGYAbwByAAoAeQBvAHUAIAB0AG8AIAB1AHMAZQAgAGkAbgAgAGMAcgBvAHMAcwBtAGEAdABjAGgAZQBzACwAIABwAG8AcwBzAGkAYgBsAHkAIAB3AGkAdABoACAAdQBwAGwAbwBhAGQAZQBkACAAdABhAGIAbABlAHMALgAKAAoAVABhAGIAbABlAHMAIABlAHgAcABvAHMAZQBkACAAdABoAHIAbwB1AGcAaAAgAHQAaABpAHMAIABlAG4AZABwAG8AaQBuAHQAIABpAG4AYwBsAHUAZABlADoAIABuAHUAYwBhAG4AZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbQBhAG4AZABhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAG4AbgBpAHMAcgBlAGQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAMQAwACAAcwBjAGgAZQBtAGEALAAgAGQAcgAxADAAIABmAHIAbwBtACAAdABoAGUAIABhAHAAYQBzAHMAIABzAGMAaABlAG0AYQAsACAAZgByAGEAbQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABhAHAAbwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQBwAHAAbABhAHUAcwBlACAAcwBjAGgAZQBtAGEALAAgAGcAZgBoACwAIABpAGQALAAgAGkAZABlAG4AdABpAGYAaQBlAGQALAAgAG0AYQBzAHQAZQByACwAIABuAGkAZAAsACAAdQBuAGkAZABlAG4AdABpAGYAaQBlAGQAIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBnAGYAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQByAGkAaABpAHAAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAdQBnAGUAcgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABwAGgAbwB0AF8AYQBsAGwALAAgAHMAcwBhAF8AdABpAG0AZQBfAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAYgBnAGQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYgBvAHkAZABlAG4AZABlACAAcwBjAGgAZQBtAGEALAAgAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYgByAG8AdwBuAGQAdwBhAHIAZgBzACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAZgBsAHUAeABwAG8AcwB2ADEAMgAwADAALAAgAGYAbAB1AHgAcABvAHMAdgA1ADAAMAAsACAAZgBsAHUAeAB2ADEAMgAwADAALAAgAGYAbAB1AHgAdgA1ADAAMAAsACAAbwBiAGoAZQBjAHQAcwAsACAAcwBwAGUAYwB0AHIAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBsAGkAZgBhAGQAcgAzACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABzAHIAYwBjAGEAdAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAIABzAGMAaABlAG0AYQAsACAAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAYQByAGMAcwAgAHMAYwBoAGUAbQBhACwAIABsAGkAbgBlAF8AdABhAHAAIABmAHIAbwBtACAAdABoAGUAIABjAGEAcwBhAF8AbABpAG4AZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1AHUAcABkAGEAdABlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAHMAOAAyAG0AbwByAHAAaABvAHoAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AIABmAHIAbwBtACAAdABoAGUAIABjAHMAdABsACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABkAGEAbgBpAHMAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBwAGwAYQB0AGUAcwAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBfAHMAcABlAGMAdAByAGEALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAG0AdQBiAGkAbgAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZQBtAGkAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABmAGsANgBqAG8AaQBuACwAIABwAGEAcgB0ADEALAAgAHAAYQByAHQAMwAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAawA2ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQByAGUAXwBzAHUAcgB2AGUAeQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABvAHIAZABlAHIAcwBtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBsAGEAcwBoAGgAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBvAHIAbgBhAHgAIABzAGMAaABlAG0AYQAsACAAZAByADIAXwB0AHMAXwBzAHMAYQAsACAAZAByADIAZQBwAG8AYwBoAGYAbAB1AHgALAAgAGQAcgAyAGwAaQBnAGgAdAAsACAAZAByADMAbABpAHQAZQAsACAAZQBkAHIAMwBsAGkAdABlACAAZgByAG8AbQAgAHQAaABlACAAZwBhAGkAYQAgAHMAYwBoAGUAbQBhACwAIABoAHkAYQBjAG8AYgAsACAAbQBhAGcAbABpAG0AcwA1ACwAIABtAGEAZwBsAGkAbQBzADYALAAgAG0AYQBnAGwAaQBtAHMANwAsACAAbQBhAGkAbgAsACAAbQBpAHMAcwBpAG4AZwBfADEAMABtAGEAcwAsACAAcgBlAGoAZQBjAHQAZQBkACwAIAByAGUAcwBvAGwAdgBlAGQAcwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBjAG4AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZwBjAHAAbQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGEAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMgBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHAAaABvAHQAbwBtAGUAdAByAHkAIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAsACAAdwBpAHQAaABwAG8AcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADMAcwBwAGUAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAGEAdQB0AG8AIABzAGMAaABlAG0AYQAsACAAbABpAHQAZQB3AGkAdABoAGQAaQBzAHQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAZABpAHMAdAAgAHMAYwBoAGUAbQBhACwAIABnAGUAbgBlAHIAYQB0AGUAZABfAGQAYQB0AGEALAAgAG0AYQBnAGwAaQBtAF8ANQAsACAAbQBhAGcAbABpAG0AXwA2ACwAIABtAGEAZwBsAGkAbQBfADcALAAgAG0AYQBpAG4ALAAgAHAAYQByAHMAZQBjAF8AcAByAG8AcABzACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBzAHAAdQByACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAHMAZQByAHYAaQBjAGUAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGwAbwB0AHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAcABzADEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAZABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABoAGkAaQBjAG8AdQBuAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAGkAcABwAGEAcgBjAG8AcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABwAHAAdQBuAGkAbwBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHMAbwB5ACAAcwBjAGgAZQBtAGEALAAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAaQBjAGUAYwB1AGIAZQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAaQBuAGYAbABpAGcAaAB0ACAAcwBjAGgAZQBtAGEALAAgAG8AYgBzAF8AcgBhAGQAaQBvACwAIABvAGIAcwBjAG8AcgBlACAAZgByAG8AbQAgAHQAaABlACAAaQB2AG8AYQAgAHMAYwBoAGUAbQBhACwAIABlAHYAZQBuAHQAcwAsACAAcABoAG8AdABwAG8AaQBuAHQAcwAsACAAdABpAG0AZQBzAGUAcgBpAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAMgBjADkAdgBzAHQAIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMAIABmAHIAbwBtACAAdABoAGUAIABrAGEAcAB0AGUAeQBuACAAcwBjAGgAZQBtAGEALAAgAGsAYQB0AGsAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAawBhAHQAawBhAHQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADUAIABzAGMAaABlAG0AYQAsACAAcwBzAGEAXwBsAHIAcwAsACAAcwBzAGEAXwBtAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADYAIABzAGMAaABlAG0AYQAsACAAZABpAHMAawBfAGIAYQBzAGkAYwAsACAAaABfAGwAaQBuAGsALAAgAGkAZABlAG4AdAAsACAAbQBlAHMAXwBiAGkAbgBhAHIAeQAsACAAbQBlAHMAXwBtAGEAcwBzAF8AcABsACwAIABtAGUAcwBfAG0AYQBzAHMAXwBzAHQALAAgAG0AZQBzAF8AcgBhAGQAaQB1AHMAXwBzAHQALAAgAG0AZQBzAF8AcwBlAHAAXwBhAG4AZwAsACAAbQBlAHMAXwB0AGUAZgBmAF8AcwB0ACwAIABvAGIAagBlAGMAdAAsACAAcABsAGEAbgBlAHQAXwBiAGEAcwBpAGMALAAgAHAAcgBvAHYAaQBkAGUAcgAsACAAcwBvAHUAcgBjAGUALAAgAHMAdABhAHIAXwBiAGEAcwBpAGMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZgBlAF8AdABkACAAcwBjAGgAZQBtAGEALAAgAGcAZQBvAGMAbwB1AG4AdABzACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwB0AGEAdABpAG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAGcAaAB0AG0AZQB0AGUAcgAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQB2AGUAcgBwAG8AbwBsACAAcwBjAGgAZQBtAGEALAAgAHIAbQB0AGEAYgBsAGUALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABsAG8AdABzAHMAcABvAGwAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwBwAG0AIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMALAAgAHcAbwBsAGYAcABhAGwAaQBzAGEAIABmAHIAbwBtACAAdABoAGUAIABsAHMAdwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbQBhAGcAaQBjACAAcwBjAGgAZQBtAGEALAAgAHIAZQBkAHUAYwBlAGQAIABmAHIAbwBtACAAdABoAGUAIABtAGEAaQBkAGEAbgBhAGsAIABzAGMAaABlAG0AYQAsACAAZQB4AHQAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYwBlAHgAdABpAG4AYwB0ACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAcwBsAGkAdABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAbQBsAHEAcwBvACAAcwBjAGgAZQBtAGEALAAgAGUAcABuAF8AYwBvAHIAZQAsACAAbQBwAGMAbwByAGIAIABmAHIAbwBtACAAdABoAGUAIABtAHAAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIABzAHQAYQByAHMAIABmAHIAbwBtACAAdABoAGUAIABtAHcAcwBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAZQAxADQAYQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbwBiAHMAYwBvAGQAZQAgAHMAYwBoAGUAbQBhACwAIABiAGkAYgByAGUAZgBzACwAIABtAGEAcABzACwAIABtAGEAcwBlAHIAcwAsACAAbQBvAG4AaQB0AG8AcgAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AaABtAGEAcwBlAHIAIABzAGMAaABlAG0AYQAsACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAbwBuAGUAYgBpAGcAYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABzAGgAYQBwAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AcABlAG4AbgBnAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAYwBjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAHQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABvAGwAYwBhAHQAcwBtAGMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABtAGEAcABzACAAZgByAG8AbQAgAHQAaABlACAAcABwAGEAawBtADMAMQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABwAG0AeAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIAB1AHMAbgBvAGMAbwByAHIAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4AGwAIABzAGMAaABlAG0AYQAsACAAbQBhAHAAMQAwACwAIABtAGEAcAA2ACwAIABtAGEAcAA3ACwAIABtAGEAcAA4ACwAIABtAGEAcAA5ACwAIABtAGEAcABfAHUAbgBpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcgBkAHUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGQAcgAyACwAIABkAHIAMwAsACAAZAByADQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAByAGEAdgBlACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABwAGgAbwB0AG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAcgBvAHMAYQB0ACAAcwBjAGgAZQBtAGEALAAgAGEAbAB0AF8AaQBkAGUAbgB0AGkAZgBpAGUAcgAsACAAYQB1AHQAaABvAHIAaQB0AGkAZQBzACwAIABjAGEAcABhAGIAaQBsAGkAdAB5ACwAIABnAF8AbgB1AG0AXwBzAHQAYQB0ACwAIABpAG4AdABlAHIAZgBhAGMAZQAsACAAaQBuAHQAZgBfAHAAYQByAGEAbQAsACAAcgBlAGcAaQBzAHQAcgBpAGUAcwAsACAAcgBlAGwAYQB0AGkAbwBuAHMAaABpAHAALAAgAHIAZQBzAF8AZABhAHQAZQAsACAAcgBlAHMAXwBkAGUAdABhAGkAbAAsACAAcgBlAHMAXwByAG8AbABlACwAIAByAGUAcwBfAHMAYwBoAGUAbQBhACwAIAByAGUAcwBfAHMAdQBiAGoAZQBjAHQALAAgAHIAZQBzAF8AdABhAGIAbABlACwAIAByAGUAcwBvAHUAcgBjAGUALAAgAHMAdABjAF8AcwBwAGEAdABpAGEAbAAsACAAcwB0AGMAXwBzAHAAZQBjAHQAcgBhAGwALAAgAHMAdABjAF8AdABlAG0AcABvAHIAYQBsACwAIABzAHUAYgBqAGUAYwB0AF8AdQBhAHQALAAgAHQAYQBiAGwAZQBfAGMAbwBsAHUAbQBuACwAIAB0AGEAcABfAHQAYQBiAGwAZQAsACAAdgBhAGwAaQBkAGEAdABpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAcgAgAHMAYwBoAGUAbQBhACwAIABvAGIAagBlAGMAdABzACwAIABwAGgAbwB0AHAAYQByACAAZgByAG8AbQAgAHQAaABlACAAcwBhAHMAbQBpAHIAYQBsAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHMAZABzAHMAZAByADEANgAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIANwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBtAGEAawBjAGUAZAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAGUAYwBpAGUAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAG0ANAAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwB1AHAAZQByAGMAbwBzAG0AbwBzACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAGcAcgBvAHUAcABzACwAIABrAGUAeQBfAGMAbwBsAHUAbQBuAHMALAAgAGsAZQB5AHMALAAgAHMAYwBoAGUAbQBhAHMALAAgAHQAYQBiAGwAZQBzACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAXwBzAGMAaABlAG0AYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAdABlAHMAdAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABlAG4AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGcAYQBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB0AGgAZQBvAHMAcwBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAbwBzAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAdwBvAG0AYQBzAHMAIABzAGMAaABlAG0AYQAsACAAaQBjAHIAcwBjAG8AcgByACwAIABtAGEAaQBuACwAIABwAHAAbQB4AGwAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwAzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQByAGEAdAAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAbABhAHQAZQBjAG8AcgByAHMALAAgAHAAbABhAHQAZQBzACwAIABwAHAAbQB4AGMAcgBvAHMAcwAsACAAcwBwAHUAcgBpAG8AdQBzACwAIAB0AHcAbwBtAGEAcwBzAGMAcgBvAHMAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAcwBuAG8AYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdgBlAHIAbwBuAHEAcwBvAHMAIABzAGMAaABlAG0AYQAsACAAcwB0AHIAaQBwAGUAOAAyACAAZgByAG8AbQAgAHQAaABlACAAdgBsAGEAcwB0AHIAaQBwAGUAOAAyACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGQAcwBkAHMAcwAxADAAIABzAGMAaABlAG0AYQAsACAAYQByAGMAaABpAHYAZQBzACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdwBmAHAAZABiACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGkAcwBlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB4AHAAcABhAHIAYQBtAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHoAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAuAAAAN2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2luZm8AAAAQAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAAAATMjAwOS0xMi0wMVQxMDowMDowMAAAABMyMDIzLTEyLTEzVDEzOjE0OjE5AAAAAAAAAAAAAAAAAAAAAH/AAAAAAAAAAAABWGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL3RhYmxlTWV0YWRhdGE6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi9hdmFpbGFiaWxpdHk6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcDo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2V4YW1wbGVzAAAA2Gl2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvZGFsaSNleGFtcGxlcwAAAHl2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2cjp3ZWJicm93c2VyAAAASHN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OgAAADw6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAA
\ No newline at end of file +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAAAAAAFWl2bzovL29yZy5nYXZvLmRjL3RhcAAAABF2czpjYXRhbG9nc2VydmljZQAAAAtHQVZPIERDIFRBUAAAABwARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAgAFQAQQBQACAAcwBlAHIAdgBpAGMAZQAAAAAAABQZAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABUAEEAUAAgAGUAbgBkACAAcABvAGkAbgB0AC4AIAAgAAoAVABoAGUAIABUAGEAYgBsAGUAIABBAGMAYwBlAHMAcwAgAFAAcgBvAHQAbwBjAG8AbAAgACgAVABBAFAAKQAgAGwAZQB0AHMAIAB5AG8AdQAgAGUAeABlAGMAdQB0AGUAIABxAHUAZQByAGkAZQBzACAAYQBnAGEAaQBuAHMAdAAgAG8AdQByAAoAZABhAHQAYQBiAGEAcwBlACAAdABhAGIAbABlAHMALAAgAGkAbgBzAHAAZQBjAHQAIAB2AGEAcgBpAG8AdQBzACAAbQBlAHQAYQBkAGEAdABhACwAIABhAG4AZAAgAHUAcABsAG8AYQBkACAAeQBvAHUAcgAgAG8AdwBuAAoAZABhAHQAYQAuACAAIAAKAAoASQBuACAARwBBAFYATwAnAHMAIABkAGEAdABhACAAYwBlAG4AdABlAHIALAAgAHcAZQAgAGkAbgAgAHAAYQByAHQAaQBjAHUAbABhAHIAIABoAG8AbABkACAAcwBlAHYAZQByAGEAbAAgAGwAYQByAGcAZQAKAGMAYQB0AGEAbABvAGcAcwAgAGwAaQBrAGUAIABQAFAATQBYAEwALAAgADIATQBBAFMAUwAgAFAAUwBDACwAIABVAFMATgBPAC0AQgAyACwAIABVAEMAQQBDADQALAAgAFcASQBTAEUALAAgAFMARABTAFMAIABEAFIAMQA2ACwACgBIAFMATwBZACwAIABhAG4AZAAgAHMAZQB2AGUAcgBhAGwAIABHAGEAaQBhACAAZABhAHQAYQAgAHIAZQBsAGUAYQBzAGUAcwAgAGEAbgBkACAAYQBuAGMAaQBsAGwAYQByAHkAIAByAGUAcwBvAHUAcgBjAGUAcwAgAGYAbwByAAoAeQBvAHUAIAB0AG8AIAB1AHMAZQAgAGkAbgAgAGMAcgBvAHMAcwBtAGEAdABjAGgAZQBzACwAIABwAG8AcwBzAGkAYgBsAHkAIAB3AGkAdABoACAAdQBwAGwAbwBhAGQAZQBkACAAdABhAGIAbABlAHMALgAKAAoAVABhAGIAbABlAHMAIABlAHgAcABvAHMAZQBkACAAdABoAHIAbwB1AGcAaAAgAHQAaABpAHMAIABlAG4AZABwAG8AaQBuAHQAIABpAG4AYwBsAHUAZABlADoAIABuAHUAYwBhAG4AZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbQBhAG4AZABhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAG4AbgBpAHMAcgBlAGQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAMQAwACAAcwBjAGgAZQBtAGEALAAgAGQAcgAxADAAIABmAHIAbwBtACAAdABoAGUAIABhAHAAYQBzAHMAIABzAGMAaABlAG0AYQAsACAAZgByAGEAbQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABhAHAAbwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQBwAHAAbABhAHUAcwBlACAAcwBjAGgAZQBtAGEALAAgAGcAZgBoACwAIABpAGQALAAgAGkAZABlAG4AdABpAGYAaQBlAGQALAAgAG0AYQBzAHQAZQByACwAIABuAGkAZAAsACAAdQBuAGkAZABlAG4AdABpAGYAaQBlAGQAIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBnAGYAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQByAGkAaABpAHAAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAdQBnAGUAcgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABwAGgAbwB0AF8AYQBsAGwALAAgAHMAcwBhAF8AdABpAG0AZQBfAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAYgBnAGQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYgBvAHkAZABlAG4AZABlACAAcwBjAGgAZQBtAGEALAAgAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYgByAG8AdwBuAGQAdwBhAHIAZgBzACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAZgBsAHUAeABwAG8AcwB2ADEAMgAwADAALAAgAGYAbAB1AHgAcABvAHMAdgA1ADAAMAAsACAAZgBsAHUAeAB2ADEAMgAwADAALAAgAGYAbAB1AHgAdgA1ADAAMAAsACAAbwBiAGoAZQBjAHQAcwAsACAAcwBwAGUAYwB0AHIAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBsAGkAZgBhAGQAcgAzACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABzAHIAYwBjAGEAdAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAIABzAGMAaABlAG0AYQAsACAAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAYQByAGMAcwAgAHMAYwBoAGUAbQBhACwAIABsAGkAbgBlAF8AdABhAHAAIABmAHIAbwBtACAAdABoAGUAIABjAGEAcwBhAF8AbABpAG4AZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1AHUAcABkAGEAdABlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAHMAOAAyAG0AbwByAHAAaABvAHoAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AIABmAHIAbwBtACAAdABoAGUAIABjAHMAdABsACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABkAGEAbgBpAHMAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBwAGwAYQB0AGUAcwAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBfAHMAcABlAGMAdAByAGEALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAG0AdQBiAGkAbgAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZQBtAGkAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABmAGsANgBqAG8AaQBuACwAIABwAGEAcgB0ADEALAAgAHAAYQByAHQAMwAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAawA2ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQByAGUAXwBzAHUAcgB2AGUAeQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABvAHIAZABlAHIAcwBtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBsAGEAcwBoAGgAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBvAHIAbgBhAHgAIABzAGMAaABlAG0AYQAsACAAZAByADIAXwB0AHMAXwBzAHMAYQAsACAAZAByADIAZQBwAG8AYwBoAGYAbAB1AHgALAAgAGQAcgAyAGwAaQBnAGgAdAAsACAAZAByADMAbABpAHQAZQAsACAAZQBkAHIAMwBsAGkAdABlACAAZgByAG8AbQAgAHQAaABlACAAZwBhAGkAYQAgAHMAYwBoAGUAbQBhACwAIABoAHkAYQBjAG8AYgAsACAAbQBhAGcAbABpAG0AcwA1ACwAIABtAGEAZwBsAGkAbQBzADYALAAgAG0AYQBnAGwAaQBtAHMANwAsACAAbQBhAGkAbgAsACAAbQBpAHMAcwBpAG4AZwBfADEAMABtAGEAcwAsACAAcgBlAGoAZQBjAHQAZQBkACwAIAByAGUAcwBvAGwAdgBlAGQAcwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBjAG4AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZwBjAHAAbQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGEAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMgBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHAAaABvAHQAbwBtAGUAdAByAHkAIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAsACAAdwBpAHQAaABwAG8AcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADMAcwBwAGUAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAGEAdQB0AG8AIABzAGMAaABlAG0AYQAsACAAbABpAHQAZQB3AGkAdABoAGQAaQBzAHQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAZABpAHMAdAAgAHMAYwBoAGUAbQBhACwAIABnAGUAbgBlAHIAYQB0AGUAZABfAGQAYQB0AGEALAAgAG0AYQBnAGwAaQBtAF8ANQAsACAAbQBhAGcAbABpAG0AXwA2ACwAIABtAGEAZwBsAGkAbQBfADcALAAgAG0AYQBpAG4ALAAgAHAAYQByAHMAZQBjAF8AcAByAG8AcABzACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBzAHAAdQByACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAHMAZQByAHYAaQBjAGUAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGwAbwB0AHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAcABzADEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAZABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABoAGkAaQBjAG8AdQBuAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAGkAcABwAGEAcgBjAG8AcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABwAHAAdQBuAGkAbwBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHMAbwB5ACAAcwBjAGgAZQBtAGEALAAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAaQBjAGUAYwB1AGIAZQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAaQBuAGYAbABpAGcAaAB0ACAAcwBjAGgAZQBtAGEALAAgAG8AYgBzAF8AcgBhAGQAaQBvACwAIABvAGIAcwBjAG8AcgBlACAAZgByAG8AbQAgAHQAaABlACAAaQB2AG8AYQAgAHMAYwBoAGUAbQBhACwAIABlAHYAZQBuAHQAcwAsACAAcABoAG8AdABwAG8AaQBuAHQAcwAsACAAdABpAG0AZQBzAGUAcgBpAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAMgBjADkAdgBzAHQAIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMAIABmAHIAbwBtACAAdABoAGUAIABrAGEAcAB0AGUAeQBuACAAcwBjAGgAZQBtAGEALAAgAGsAYQB0AGsAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAawBhAHQAawBhAHQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADUAIABzAGMAaABlAG0AYQAsACAAcwBzAGEAXwBsAHIAcwAsACAAcwBzAGEAXwBtAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADYAIABzAGMAaABlAG0AYQAsACAAZABpAHMAawBfAGIAYQBzAGkAYwAsACAAaABfAGwAaQBuAGsALAAgAGkAZABlAG4AdAAsACAAbQBlAHMAXwBiAGkAbgBhAHIAeQAsACAAbQBlAHMAXwBtAGEAcwBzAF8AcABsACwAIABtAGUAcwBfAG0AYQBzAHMAXwBzAHQALAAgAG0AZQBzAF8AcgBhAGQAaQB1AHMAXwBzAHQALAAgAG0AZQBzAF8AcwBlAHAAXwBhAG4AZwAsACAAbQBlAHMAXwB0AGUAZgBmAF8AcwB0ACwAIABvAGIAagBlAGMAdAAsACAAcABsAGEAbgBlAHQAXwBiAGEAcwBpAGMALAAgAHAAcgBvAHYAaQBkAGUAcgAsACAAcwBvAHUAcgBjAGUALAAgAHMAdABhAHIAXwBiAGEAcwBpAGMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZgBlAF8AdABkACAAcwBjAGgAZQBtAGEALAAgAGcAZQBvAGMAbwB1AG4AdABzACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwB0AGEAdABpAG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAGcAaAB0AG0AZQB0AGUAcgAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQB2AGUAcgBwAG8AbwBsACAAcwBjAGgAZQBtAGEALAAgAHIAbQB0AGEAYgBsAGUALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABsAG8AdABzAHMAcABvAGwAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwBwAG0AIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMALAAgAHcAbwBsAGYAcABhAGwAaQBzAGEAIABmAHIAbwBtACAAdABoAGUAIABsAHMAdwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbQBhAGcAaQBjACAAcwBjAGgAZQBtAGEALAAgAHIAZQBkAHUAYwBlAGQAIABmAHIAbwBtACAAdABoAGUAIABtAGEAaQBkAGEAbgBhAGsAIABzAGMAaABlAG0AYQAsACAAZQB4AHQAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYwBlAHgAdABpAG4AYwB0ACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAcwBsAGkAdABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAbQBsAHEAcwBvACAAcwBjAGgAZQBtAGEALAAgAGUAcABuAF8AYwBvAHIAZQAsACAAbQBwAGMAbwByAGIAIABmAHIAbwBtACAAdABoAGUAIABtAHAAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIABzAHQAYQByAHMAIABmAHIAbwBtACAAdABoAGUAIABtAHcAcwBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAZQAxADQAYQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbwBiAHMAYwBvAGQAZQAgAHMAYwBoAGUAbQBhACwAIABiAGkAYgByAGUAZgBzACwAIABtAGEAcABzACwAIABtAGEAcwBlAHIAcwAsACAAbQBvAG4AaQB0AG8AcgAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AaABtAGEAcwBlAHIAIABzAGMAaABlAG0AYQAsACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAbwBuAGUAYgBpAGcAYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABzAGgAYQBwAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AcABlAG4AbgBnAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAYwBjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAHQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABvAGwAYwBhAHQAcwBtAGMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABtAGEAcABzACAAZgByAG8AbQAgAHQAaABlACAAcABwAGEAawBtADMAMQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABwAG0AeAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIAB1AHMAbgBvAGMAbwByAHIAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4AGwAIABzAGMAaABlAG0AYQAsACAAbQBhAHAAMQAwACwAIABtAGEAcAA2ACwAIABtAGEAcAA3ACwAIABtAGEAcAA4ACwAIABtAGEAcAA5ACwAIABtAGEAcABfAHUAbgBpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcgBkAHUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGQAcgAyACwAIABkAHIAMwAsACAAZAByADQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAByAGEAdgBlACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABwAGgAbwB0AG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAcgBvAHMAYQB0ACAAcwBjAGgAZQBtAGEALAAgAGEAbAB0AF8AaQBkAGUAbgB0AGkAZgBpAGUAcgAsACAAYQB1AHQAaABvAHIAaQB0AGkAZQBzACwAIABjAGEAcABhAGIAaQBsAGkAdAB5ACwAIABnAF8AbgB1AG0AXwBzAHQAYQB0ACwAIABpAG4AdABlAHIAZgBhAGMAZQAsACAAaQBuAHQAZgBfAHAAYQByAGEAbQAsACAAcgBlAGcAaQBzAHQAcgBpAGUAcwAsACAAcgBlAGwAYQB0AGkAbwBuAHMAaABpAHAALAAgAHIAZQBzAF8AZABhAHQAZQAsACAAcgBlAHMAXwBkAGUAdABhAGkAbAAsACAAcgBlAHMAXwByAG8AbABlACwAIAByAGUAcwBfAHMAYwBoAGUAbQBhACwAIAByAGUAcwBfAHMAdQBiAGoAZQBjAHQALAAgAHIAZQBzAF8AdABhAGIAbABlACwAIAByAGUAcwBvAHUAcgBjAGUALAAgAHMAdABjAF8AcwBwAGEAdABpAGEAbAAsACAAcwB0AGMAXwBzAHAAZQBjAHQAcgBhAGwALAAgAHMAdABjAF8AdABlAG0AcABvAHIAYQBsACwAIABzAHUAYgBqAGUAYwB0AF8AdQBhAHQALAAgAHQAYQBiAGwAZQBfAGMAbwBsAHUAbQBuACwAIAB0AGEAcABfAHQAYQBiAGwAZQAsACAAdgBhAGwAaQBkAGEAdABpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAcgAgAHMAYwBoAGUAbQBhACwAIABvAGIAagBlAGMAdABzACwAIABwAGgAbwB0AHAAYQByACAAZgByAG8AbQAgAHQAaABlACAAcwBhAHMAbQBpAHIAYQBsAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHMAZABzAHMAZAByADEANgAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIANwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBtAGEAawBjAGUAZAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAGUAYwBpAGUAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAG0ANAAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwB1AHAAZQByAGMAbwBzAG0AbwBzACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAGcAcgBvAHUAcABzACwAIABrAGUAeQBfAGMAbwBsAHUAbQBuAHMALAAgAGsAZQB5AHMALAAgAHMAYwBoAGUAbQBhAHMALAAgAHQAYQBiAGwAZQBzACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAXwBzAGMAaABlAG0AYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAdABlAHMAdAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABlAG4AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGcAYQBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB0AGgAZQBvAHMAcwBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAbwBzAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAdwBvAG0AYQBzAHMAIABzAGMAaABlAG0AYQAsACAAaQBjAHIAcwBjAG8AcgByACwAIABtAGEAaQBuACwAIABwAHAAbQB4AGwAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwAzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQByAGEAdAAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAbABhAHQAZQBjAG8AcgByAHMALAAgAHAAbABhAHQAZQBzACwAIABwAHAAbQB4AGMAcgBvAHMAcwAsACAAcwBwAHUAcgBpAG8AdQBzACwAIAB0AHcAbwBtAGEAcwBzAGMAcgBvAHMAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAcwBuAG8AYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdgBlAHIAbwBuAHEAcwBvAHMAIABzAGMAaABlAG0AYQAsACAAcwB0AHIAaQBwAGUAOAAyACAAZgByAG8AbQAgAHQAaABlACAAdgBsAGEAcwB0AHIAaQBwAGUAOAAyACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGQAcwBkAHMAcwAxADAAIABzAGMAaABlAG0AYQAsACAAYQByAGMAaABpAHYAZQBzACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdwBmAHAAZABiACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGkAcwBlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB4AHAAcABhAHIAYQBtAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHoAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAuAAAAN2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2luZm8AAAAQAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAAAATMjAwOS0xMi0wMVQxMDowMDowMAAAABMyMDI0LTAyLTA2VDEwOjE5OjMzAAAAAAAAAAAAAAAAAAAAAH/AAAAAAAAAAAABWGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvdGFwAAAA2Gl2bzovL2l2b2EubmV0L3N0ZC9kYWxpI2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3RhcAAAAHl2cjp3ZWJicm93c2VyOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAASDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAADw6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAA \ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta index e93eb408a38cdd1d0da405f172fe70233be10c8e..73461fed6a2d18738423e4eccf7834b064b5deb3 100644 GIT binary patch delta 85 zcmbOvK1qDSKgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&yLD^s)0;*2_sBBt8uCPo%1W(H<@ mDIjSBBLj=g;YkXo9Q;ZZv!BgG5I+04P(#RdQf-5P`d diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index c82fbbcb..3c75d2b3 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -54,9 +54,8 @@ def test_cone_and_spectral_point(_all_constraint_responses): space=(134, 11, 0.1), spectrum=600*u.eV) - # TODO: this needs to be the obscore service when we have fixed - # obscore discovery - assert ("SIA2 GAVO Data Center SIAP Version 2 Service: 8 records" + assert ("Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because" + " it is served by ivo://org.gavo.dc/__system__/obscore/obscore" in logs) assert len(images) == 8 From 475028069c0629a2aa7243d1b8361da01108b47f Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 8 Feb 2024 14:43:03 +0100 Subject: [PATCH 13/38] Global discovery now elides duplicate images found based on their access URLs. --- pyvo/discover/image.py | 66 +++++++++++------- ...ah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R | 17 +++++ ...i-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta | Bin 0 -> 1814 bytes ...ah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo | 17 +++++ ...i-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta | Bin 0 -> 1814 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg | 23 ++++++ ...ST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta | Bin 0 -> 2962 bytes pyvo/discover/tests/test_imagediscovery.py | 26 +++++++ 8 files changed, 125 insertions(+), 24 deletions(-) create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index caa70f5d..08716050 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -24,7 +24,7 @@ # imports for type hints -from typing import Callable, List, Optional, Set, Tuple +from typing import Callable, Generator, List, Optional, Set, Tuple from astropy.units.quantity import Quantity @@ -166,6 +166,7 @@ def __init__(self, self.watcher = watcher self.log_messages: List[str] = [] self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] + self.known_access_urls: Set[str] = set() def _info(self, message: str) -> None: """sends message to our watcher (if there is any) @@ -282,18 +283,24 @@ def discover_services(self): self._purge_redundant_services() def set_services(self, - registry_results: registry.RegistryResults) -> None: + registry_results: registry.RegistryResults, + purge_redundant: bool = True) -> None: """as an alternative to discover_services, this sets the services to be queried to the result of a custom registry query. This will pick the "most capabable" interface from each record and ignore records without image discovery capabilities. + + If you set purge_redundant to false, this will not attempt + to eliminate services that are alternative interfaces to services + that are already called. There are very few situations in which + you would want to do that, mostly related to debugging. """ for rsc in registry_results: if "tap" in rsc.access_modes(): # TODO: we ought to ensure there's an obscore - # table on this; but then: let's rather fix obscore - # discovery + # table on this; but by the time this sees users, + # I hope to have fixed obscore discovery. self.obscore_recs.append(Queriable(rsc)) elif "sia2" in rsc.access_modes(): self.sia2_recs.append(Queriable(rsc)) @@ -301,7 +308,26 @@ def set_services(self, self.sia1_recs.append(Queriable(rsc)) # else ignore this record - self._purge_redundant_services() + if purge_redundant: + self._purge_redundant_services() + + def _add_records(self, + recgen: Generator[ImageFound, None, None]) -> int: + """adds records from regen to the global results. + + This will skip datasets the access urls of which we have already seen + and will return the number of datasets actually added. + """ + n_added = 0 + + for obscore_record in recgen: + if obscore_record.access_url in self.known_access_urls: + continue + self.known_access_urls.add(obscore_record.access_url) + self.results.append(obscore_record) + n_added += 1 + + return n_added def _query_one_sia1(self, rec: Queriable): """runs our query against a SIA1 capability of rec. @@ -330,15 +356,12 @@ def non_spatial_filter(sia1_rec): self._info("Querying SIA1 {}...".format(rec.title)) svc = rec.res_rec.get_service("sia") - found = list(ImageFound.from_sia1_recs( + n_found = self.add_records( + ImageFound.from_sia1_recs( svc.search( pos=self.center, size=self.radius, intersect='overlaps'), non_spatial_filter)) - self._log("SIA1 {} {} records".format( - rec.title, - len(found))) - - self.results.extend(found) + self._log(f"SIA1 {rec.title} {n_found} records") def _query_sia1(self): """runs the SIA1 part of our discovery. @@ -371,12 +394,9 @@ def _query_one_sia2(self, rec: Queriable): if self.time is not None: constraints["time"] = time.Time(self.time, format="mjd") - matches = list( + n_found = self.add_records( ImageFound.from_obscore_recs(svc.search(**constraints))) - self._log("SIA2 {}: {} records".format( - rec.title, - len(matches))) - self.results.extend(matches) + self._log(f"SIA2 {rec.title}: {n_found} records") def _query_sia2(self): """runs the SIA2 part of our discovery. @@ -392,13 +412,11 @@ def _query_one_obscore(self, rec: Queriable, where_clause:str): """ self._info("Querying Obscore {}...".format(rec.title)) svc = rec.res_rec.get_service("tap") - recs = svc.run_sync("select * from ivoa.obscore "+where_clause) - matches = list(ImageFound.from_obscore_recs(recs)) - self._log("Obscore {}: {} records".format( - rec.title, - len(matches))) - self.results.extend(matches) + n_found = self._add_records( + ImageFound.from_obscore_recs( + svc.run_sync("select * from ivoa.obscore "+where_clause))) + self._log(f"Obscore {rec.title}: {n_found} records") def _query_obscore(self): """runs the Obscore part of our discovery. @@ -440,9 +458,9 @@ def query_services(self): raise dal.DALQueryError("No services to query. Unless" " you overrode service selection, you will have to" " loosen your constraints.") - self._query_sia1() - self._query_sia2() self._query_obscore() + self._query_sia2() + self._query_sia1() def images_globally( diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R new file mode 100644 index 00000000..a9e7cc7d --- /dev/null +++ b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R @@ -0,0 +1,17 @@ + +Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. +The calib_level flag takes the following values: + +=== =========================================================== + 0 Raw Instrumental data requiring instrument-specific tools + 1 Instrumental data processable with standard tools + 2 Calibrated, science-ready data without instrument signature + 3 Enhanced data products (e.g., mosaics) +=== ===========================================================High level scientific classification of the data product, taken from an enumerationData product specific typeAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.Name of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.
A datalink service accompanying obscore. This will forward to data +collection-specific datalink services if they exist or return +extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta new file mode 100644 index 0000000000000000000000000000000000000000..237462aad0d34b0f8e54793b6a9b4904fa91fd6a GIT binary patch literal 1814 zcmaJ?&2HO95H@PraxFKuW3*_|22c+Q?8u@d%JCoIgJ7v~6IYgHr9ltDVo8of#w3^F zE-fj5f#y=wz}~ujg1$-*eT69O9fO_$d%(_4wh`EwmF}zKH3vO@`C$>mp(B4zZ;m43e$UWiRK*O_z`a|u!SGP(o z6E0W`O6F|l`(O)?g_x7Oh_NI%)7TEacT>bP5aPSNu&?B1cj{}-d|BH~!fSBU zZ&;o~d;>9VuF}n;20cByDx1cUVdlla;{u#lV3o~^Q8Ow!C*x3o7s@oo%cHKF?B*+n z`5(Z_n-y~}U#%V2j*j;Z^3Q(i>i9LAg#toR5~B$7)=pEiJ2tsA0 zKCZW8h$uEPtuRkp4nVlf!S8HeTy>RPOk!WjZC8lsxLkH@;~jO4B=kxycv#DVxNkU6 z7BnjJQD`goGk0kWp}XSdb~HY#2{yY#``8L4S6^zQJ~0lW(a#su zS*z*DPm|#L`y?0)2BjX0gA(?9%;hmzH5pcLs@S!s$7W*&=FGL3qR3CjLC2Au0&<@om13Uv?)S-an5hf}~4z`4e2gIGQe z893?9x!OS=^?f$@z}J!)60(7M{@1^MLt?pSx5{-=LuM@IV7ve8G%sH^uev7=yG$S+ zJwC6uo}JVim*`4WkCLxQ)73e0A3BG>fP>6ff(bW)iI; zg<7Lv9(Vx`6RyR2tAXi<5RkwN3$;@`-ZLuqpBj`ZlSmy#hlN`6qhST}Xj)UuOI8mL z_YaNA_ypb45~&+=bQh6$T$L+MDT;jFmKlwel3#yJgp~Yzu0wJ`xrv(y^&Y_`Zzq={ z!V7?*vo!@3MbhzN#DSwPOU9fWX~yIKCk7hec8S;!>y#BuoS`1Vv9if^V&fl-%zj|% IF0m5hf5mIAF8}}l literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo new file mode 100644 index 00000000..919491c2 --- /dev/null +++ b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo @@ -0,0 +1,17 @@ + +Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. +The calib_level flag takes the following values: + +=== =========================================================== + 0 Raw Instrumental data requiring instrument-specific tools + 1 Instrumental data processable with standard tools + 2 Calibrated, science-ready data without instrument signature + 3 Enhanced data products (e.g., mosaics) +=== ===========================================================High level scientific classification of the data product, taken from an enumerationData product specific typeAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.Name of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.AAAABWltYWdlAAAAAAABAAAAFlBvdHNkYW0gS2FwdGV5biBTZXJpZXMAAAAka2FwdGV5bi9kYXRhL2ZpdHMvUE9UMDgwXzAwMDA5MS5maXRzAAAAMVBvdHNkYW0gS2FwdGV5biBTZXJpZXMgOTEgZm9yIDA3QSBLYXB0ZXluLVNwZWNpYWwAAAA4aXZvOi8vb3JnLmdhdm8uZGMvfj9rYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHMAAAAAAAAAcWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUva2FwdGV5bi9xL2RsL2RsbWV0YT9JRD1pdm86Ly9vcmcuZ2F2by5kYy9+JTNGa2FwdGV5bi9kYXRhL2ZpdHMvUE9UMDgwXzAwMDA5MS5maXRzAAAAJmFwcGxpY2F0aW9uL3gtdm90YWJsZTtjb250ZW50PWRhdGFsaW5rAAAAAAAAAAoAAAATMDdBIEthcHRleW4tU3BlY2lhbAAAAAZSZWdpb25AclwQTUeO30A9dXYbNgBKP3OSbT8Yer0AAAB/UG9seWdvbiBJQ1JTIDI5NC4wNTY4MDI1MjQgMjkuMTY2MTM5NTA5NyAyOTMuNDU0MzI3MDM4NSAyOS4xNTgwMTI5ODIxIDI5My40NDQwNDYyMDQ3IDI5Ljc1MzcyOTAwNTMgMjk0LjA1NjA4ODEyNzEgMjkuNzU5NTY2Njk4MT9hnWJiMQjIQNJswAAAAABA0mzAAAAAAH/AAAB/wAAAPpmAWayZpoU+oXLEF8dx73/4AAAAAAAAAAAABmVtLm9wdAAAAAAAAAAKQU8gUG90c2RhbQAAABhHcmVhdCBSZWZyYWN0b3IgLSBQT1QwODAAAAAAAAAfQAAAAAAAABu8////////////////////////////////P2GdYmIxCMgAAAAAAAAAXGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9rYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHM/cHJldmlldz1UcnVlAAAADmthcHRleW4ucGxhdGVz
A datalink service accompanying obscore. This will forward to data +collection-specific datalink services if they exist or return +extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta new file mode 100644 index 0000000000000000000000000000000000000000..d6cf0c9dfe89e837c78ed225530e1f6b9210acd8 GIT binary patch literal 1814 zcmaJ?&2HO95H@PraxFKuW3*_|22c+Q?8u@d%JCoIgJ7v~6IYgHr9ltDVo8of#w3^F zE-fj5f#y=wz}~ujqXO+K^bz_Nos}plJ|w*C&g{%^Io~%Qf6e@v%Px$cTeU57Tu_m4 zVlxNSi+^O+1?oV|mE4NqZ30|ygNrz^MG}Mdo>C4!h8#lf3GW6Po-NcLYUjPWRdShd z!D3J{XEWaiTX-zQoZLl>CBd1-cJRHMBBmklL0p0m-|dBcB{#cMUvuWm+HMkFgQI@K z@*LtDh;eh3ZXPx0>Dg7;G>!~2F9seL;JgB>Y*vh#QPDXWhYGwnM25!q0G7DUv7BB+D#>YOc zw_}JXHZrX+Pg@Q^xXi)tY+qb;m0V0>U&(D(i0HUnc5LGvb&VwSN-lU<%YwLXI8YWe zD)UijEB7;ZX$+ye;^uZVKC1~fyF~lg3ME%xYNI|e4x-V|7v-w4j}>le`^CO(^?Hu^ z)Nph|D<*cgJ;K|B<(g5gA}-tKUYHDbba&UOZ9^nJzBvu$;QRX|7z_rb9*ct#_I%9cFOCp9m z8{r)_hQ=i64Ti|A2J~p+i%C{{5|$1i@+SnrZHmJDcax7ErKp`6Sj zT5`=rHl&v{G3*PRbew16uz-3YI=)REX(f_`IDcNx)2zoge3c%D{Qk+E+?b!F#a=AP z@8(Vpf_Nb+2=(!8zK>saCm-HFk0^qqOM#8rL!y`ohPr~?T+&U!b#cJC#%qIEJ`Nc; z>CL&?K_B&fHu%8Tk{J@RfqMS;zkfkuxo5Y^by7oSEaqUl|LZg_UpBA0Cl0$zARawF zueY9^)Ek%QkI~=x<%EOQwPL}n7ke=airx*Q2D7-0x>tO4*6cKks5lfa>!4;5ts;e5 zqhKC*0S*(c#d@oO>4y-IzzYktQ#{@?D)*lnlq!=*9Y%+RTJxh}1@mZHQ_M?N4-fYb zjLP@~-P01O8*_9Qk$7C|_6kaSgi;Oawc_#t(Y-(hYK3Q^Y9*S=0Ts53;@grrf=nkU zM1m8X6*PR$GSJ3+nQQB{0~{%eeBPEBjg^vLe@ujw{CuuMazVL?n+WwD!6k1emm|Up zfT6QB1r9>TG*$#r7mAB@a?VCpWh G661dYrmklI literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg new file mode 100644 index 00000000..84858f8d --- /dev/null +++ b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg @@ -0,0 +1,23 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAAAAAAFWl2bzovL29yZy5nYXZvLmRjL3RhcAAAABF2czpjYXRhbG9nc2VydmljZQAAAAtHQVZPIERDIFRBUAAAABwARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAgAFQAQQBQACAAcwBlAHIAdgBpAGMAZQAAAAAAABQZAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABUAEEAUAAgAGUAbgBkACAAcABvAGkAbgB0AC4AIAAgAAoAVABoAGUAIABUAGEAYgBsAGUAIABBAGMAYwBlAHMAcwAgAFAAcgBvAHQAbwBjAG8AbAAgACgAVABBAFAAKQAgAGwAZQB0AHMAIAB5AG8AdQAgAGUAeABlAGMAdQB0AGUAIABxAHUAZQByAGkAZQBzACAAYQBnAGEAaQBuAHMAdAAgAG8AdQByAAoAZABhAHQAYQBiAGEAcwBlACAAdABhAGIAbABlAHMALAAgAGkAbgBzAHAAZQBjAHQAIAB2AGEAcgBpAG8AdQBzACAAbQBlAHQAYQBkAGEAdABhACwAIABhAG4AZAAgAHUAcABsAG8AYQBkACAAeQBvAHUAcgAgAG8AdwBuAAoAZABhAHQAYQAuACAAIAAKAAoASQBuACAARwBBAFYATwAnAHMAIABkAGEAdABhACAAYwBlAG4AdABlAHIALAAgAHcAZQAgAGkAbgAgAHAAYQByAHQAaQBjAHUAbABhAHIAIABoAG8AbABkACAAcwBlAHYAZQByAGEAbAAgAGwAYQByAGcAZQAKAGMAYQB0AGEAbABvAGcAcwAgAGwAaQBrAGUAIABQAFAATQBYAEwALAAgADIATQBBAFMAUwAgAFAAUwBDACwAIABVAFMATgBPAC0AQgAyACwAIABVAEMAQQBDADQALAAgAFcASQBTAEUALAAgAFMARABTAFMAIABEAFIAMQA2ACwACgBIAFMATwBZACwAIABhAG4AZAAgAHMAZQB2AGUAcgBhAGwAIABHAGEAaQBhACAAZABhAHQAYQAgAHIAZQBsAGUAYQBzAGUAcwAgAGEAbgBkACAAYQBuAGMAaQBsAGwAYQByAHkAIAByAGUAcwBvAHUAcgBjAGUAcwAgAGYAbwByAAoAeQBvAHUAIAB0AG8AIAB1AHMAZQAgAGkAbgAgAGMAcgBvAHMAcwBtAGEAdABjAGgAZQBzACwAIABwAG8AcwBzAGkAYgBsAHkAIAB3AGkAdABoACAAdQBwAGwAbwBhAGQAZQBkACAAdABhAGIAbABlAHMALgAKAAoAVABhAGIAbABlAHMAIABlAHgAcABvAHMAZQBkACAAdABoAHIAbwB1AGcAaAAgAHQAaABpAHMAIABlAG4AZABwAG8AaQBuAHQAIABpAG4AYwBsAHUAZABlADoAIABuAHUAYwBhAG4AZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbQBhAG4AZABhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAG4AbgBpAHMAcgBlAGQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAMQAwACAAcwBjAGgAZQBtAGEALAAgAGQAcgAxADAAIABmAHIAbwBtACAAdABoAGUAIABhAHAAYQBzAHMAIABzAGMAaABlAG0AYQAsACAAZgByAGEAbQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABhAHAAbwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQBwAHAAbABhAHUAcwBlACAAcwBjAGgAZQBtAGEALAAgAGcAZgBoACwAIABpAGQALAAgAGkAZABlAG4AdABpAGYAaQBlAGQALAAgAG0AYQBzAHQAZQByACwAIABuAGkAZAAsACAAdQBuAGkAZABlAG4AdABpAGYAaQBlAGQAIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBnAGYAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQByAGkAaABpAHAAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAdQBnAGUAcgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABwAGgAbwB0AF8AYQBsAGwALAAgAHMAcwBhAF8AdABpAG0AZQBfAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAYgBnAGQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYgBvAHkAZABlAG4AZABlACAAcwBjAGgAZQBtAGEALAAgAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYgByAG8AdwBuAGQAdwBhAHIAZgBzACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAZgBsAHUAeABwAG8AcwB2ADEAMgAwADAALAAgAGYAbAB1AHgAcABvAHMAdgA1ADAAMAAsACAAZgBsAHUAeAB2ADEAMgAwADAALAAgAGYAbAB1AHgAdgA1ADAAMAAsACAAbwBiAGoAZQBjAHQAcwAsACAAcwBwAGUAYwB0AHIAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBsAGkAZgBhAGQAcgAzACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABzAHIAYwBjAGEAdAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAIABzAGMAaABlAG0AYQAsACAAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAYQByAGMAcwAgAHMAYwBoAGUAbQBhACwAIABsAGkAbgBlAF8AdABhAHAAIABmAHIAbwBtACAAdABoAGUAIABjAGEAcwBhAF8AbABpAG4AZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1AHUAcABkAGEAdABlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAHMAOAAyAG0AbwByAHAAaABvAHoAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AIABmAHIAbwBtACAAdABoAGUAIABjAHMAdABsACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABkAGEAbgBpAHMAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBwAGwAYQB0AGUAcwAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBfAHMAcABlAGMAdAByAGEALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAG0AdQBiAGkAbgAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZQBtAGkAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABmAGsANgBqAG8AaQBuACwAIABwAGEAcgB0ADEALAAgAHAAYQByAHQAMwAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAawA2ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQByAGUAXwBzAHUAcgB2AGUAeQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABvAHIAZABlAHIAcwBtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBsAGEAcwBoAGgAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBvAHIAbgBhAHgAIABzAGMAaABlAG0AYQAsACAAZAByADIAXwB0AHMAXwBzAHMAYQAsACAAZAByADIAZQBwAG8AYwBoAGYAbAB1AHgALAAgAGQAcgAyAGwAaQBnAGgAdAAsACAAZAByADMAbABpAHQAZQAsACAAZQBkAHIAMwBsAGkAdABlACAAZgByAG8AbQAgAHQAaABlACAAZwBhAGkAYQAgAHMAYwBoAGUAbQBhACwAIABoAHkAYQBjAG8AYgAsACAAbQBhAGcAbABpAG0AcwA1ACwAIABtAGEAZwBsAGkAbQBzADYALAAgAG0AYQBnAGwAaQBtAHMANwAsACAAbQBhAGkAbgAsACAAbQBpAHMAcwBpAG4AZwBfADEAMABtAGEAcwAsACAAcgBlAGoAZQBjAHQAZQBkACwAIAByAGUAcwBvAGwAdgBlAGQAcwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBjAG4AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZwBjAHAAbQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGEAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMgBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHAAaABvAHQAbwBtAGUAdAByAHkAIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAsACAAdwBpAHQAaABwAG8AcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADMAcwBwAGUAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAGEAdQB0AG8AIABzAGMAaABlAG0AYQAsACAAbABpAHQAZQB3AGkAdABoAGQAaQBzAHQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAZABpAHMAdAAgAHMAYwBoAGUAbQBhACwAIABnAGUAbgBlAHIAYQB0AGUAZABfAGQAYQB0AGEALAAgAG0AYQBnAGwAaQBtAF8ANQAsACAAbQBhAGcAbABpAG0AXwA2ACwAIABtAGEAZwBsAGkAbQBfADcALAAgAG0AYQBpAG4ALAAgAHAAYQByAHMAZQBjAF8AcAByAG8AcABzACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBzAHAAdQByACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAHMAZQByAHYAaQBjAGUAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGwAbwB0AHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAcABzADEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAZABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABoAGkAaQBjAG8AdQBuAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAGkAcABwAGEAcgBjAG8AcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABwAHAAdQBuAGkAbwBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHMAbwB5ACAAcwBjAGgAZQBtAGEALAAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAaQBjAGUAYwB1AGIAZQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAaQBuAGYAbABpAGcAaAB0ACAAcwBjAGgAZQBtAGEALAAgAG8AYgBzAF8AcgBhAGQAaQBvACwAIABvAGIAcwBjAG8AcgBlACAAZgByAG8AbQAgAHQAaABlACAAaQB2AG8AYQAgAHMAYwBoAGUAbQBhACwAIABlAHYAZQBuAHQAcwAsACAAcABoAG8AdABwAG8AaQBuAHQAcwAsACAAdABpAG0AZQBzAGUAcgBpAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAMgBjADkAdgBzAHQAIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMAIABmAHIAbwBtACAAdABoAGUAIABrAGEAcAB0AGUAeQBuACAAcwBjAGgAZQBtAGEALAAgAGsAYQB0AGsAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAawBhAHQAawBhAHQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADUAIABzAGMAaABlAG0AYQAsACAAcwBzAGEAXwBsAHIAcwAsACAAcwBzAGEAXwBtAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADYAIABzAGMAaABlAG0AYQAsACAAZABpAHMAawBfAGIAYQBzAGkAYwAsACAAaABfAGwAaQBuAGsALAAgAGkAZABlAG4AdAAsACAAbQBlAHMAXwBiAGkAbgBhAHIAeQAsACAAbQBlAHMAXwBtAGEAcwBzAF8AcABsACwAIABtAGUAcwBfAG0AYQBzAHMAXwBzAHQALAAgAG0AZQBzAF8AcgBhAGQAaQB1AHMAXwBzAHQALAAgAG0AZQBzAF8AcwBlAHAAXwBhAG4AZwAsACAAbQBlAHMAXwB0AGUAZgBmAF8AcwB0ACwAIABvAGIAagBlAGMAdAAsACAAcABsAGEAbgBlAHQAXwBiAGEAcwBpAGMALAAgAHAAcgBvAHYAaQBkAGUAcgAsACAAcwBvAHUAcgBjAGUALAAgAHMAdABhAHIAXwBiAGEAcwBpAGMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZgBlAF8AdABkACAAcwBjAGgAZQBtAGEALAAgAGcAZQBvAGMAbwB1AG4AdABzACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwB0AGEAdABpAG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAGcAaAB0AG0AZQB0AGUAcgAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQB2AGUAcgBwAG8AbwBsACAAcwBjAGgAZQBtAGEALAAgAHIAbQB0AGEAYgBsAGUALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABsAG8AdABzAHMAcABvAGwAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwBwAG0AIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMALAAgAHcAbwBsAGYAcABhAGwAaQBzAGEAIABmAHIAbwBtACAAdABoAGUAIABsAHMAdwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbQBhAGcAaQBjACAAcwBjAGgAZQBtAGEALAAgAHIAZQBkAHUAYwBlAGQAIABmAHIAbwBtACAAdABoAGUAIABtAGEAaQBkAGEAbgBhAGsAIABzAGMAaABlAG0AYQAsACAAZQB4AHQAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYwBlAHgAdABpAG4AYwB0ACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAcwBsAGkAdABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAbQBsAHEAcwBvACAAcwBjAGgAZQBtAGEALAAgAGUAcABuAF8AYwBvAHIAZQAsACAAbQBwAGMAbwByAGIAIABmAHIAbwBtACAAdABoAGUAIABtAHAAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIABzAHQAYQByAHMAIABmAHIAbwBtACAAdABoAGUAIABtAHcAcwBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAZQAxADQAYQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbwBiAHMAYwBvAGQAZQAgAHMAYwBoAGUAbQBhACwAIABiAGkAYgByAGUAZgBzACwAIABtAGEAcABzACwAIABtAGEAcwBlAHIAcwAsACAAbQBvAG4AaQB0AG8AcgAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AaABtAGEAcwBlAHIAIABzAGMAaABlAG0AYQAsACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAbwBuAGUAYgBpAGcAYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABzAGgAYQBwAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AcABlAG4AbgBnAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAYwBjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAHQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABvAGwAYwBhAHQAcwBtAGMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABtAGEAcABzACAAZgByAG8AbQAgAHQAaABlACAAcABwAGEAawBtADMAMQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABwAG0AeAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIAB1AHMAbgBvAGMAbwByAHIAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4AGwAIABzAGMAaABlAG0AYQAsACAAbQBhAHAAMQAwACwAIABtAGEAcAA2ACwAIABtAGEAcAA3ACwAIABtAGEAcAA4ACwAIABtAGEAcAA5ACwAIABtAGEAcABfAHUAbgBpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcgBkAHUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGQAcgAyACwAIABkAHIAMwAsACAAZAByADQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAByAGEAdgBlACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABwAGgAbwB0AG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAcgBvAHMAYQB0ACAAcwBjAGgAZQBtAGEALAAgAGEAbAB0AF8AaQBkAGUAbgB0AGkAZgBpAGUAcgAsACAAYQB1AHQAaABvAHIAaQB0AGkAZQBzACwAIABjAGEAcABhAGIAaQBsAGkAdAB5ACwAIABnAF8AbgB1AG0AXwBzAHQAYQB0ACwAIABpAG4AdABlAHIAZgBhAGMAZQAsACAAaQBuAHQAZgBfAHAAYQByAGEAbQAsACAAcgBlAGcAaQBzAHQAcgBpAGUAcwAsACAAcgBlAGwAYQB0AGkAbwBuAHMAaABpAHAALAAgAHIAZQBzAF8AZABhAHQAZQAsACAAcgBlAHMAXwBkAGUAdABhAGkAbAAsACAAcgBlAHMAXwByAG8AbABlACwAIAByAGUAcwBfAHMAYwBoAGUAbQBhACwAIAByAGUAcwBfAHMAdQBiAGoAZQBjAHQALAAgAHIAZQBzAF8AdABhAGIAbABlACwAIAByAGUAcwBvAHUAcgBjAGUALAAgAHMAdABjAF8AcwBwAGEAdABpAGEAbAAsACAAcwB0AGMAXwBzAHAAZQBjAHQAcgBhAGwALAAgAHMAdABjAF8AdABlAG0AcABvAHIAYQBsACwAIABzAHUAYgBqAGUAYwB0AF8AdQBhAHQALAAgAHQAYQBiAGwAZQBfAGMAbwBsAHUAbQBuACwAIAB0AGEAcABfAHQAYQBiAGwAZQAsACAAdgBhAGwAaQBkAGEAdABpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAcgAgAHMAYwBoAGUAbQBhACwAIABvAGIAagBlAGMAdABzACwAIABwAGgAbwB0AHAAYQByACAAZgByAG8AbQAgAHQAaABlACAAcwBhAHMAbQBpAHIAYQBsAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHMAZABzAHMAZAByADEANgAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIANwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBtAGEAawBjAGUAZAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAGUAYwBpAGUAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAG0ANAAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwB1AHAAZQByAGMAbwBzAG0AbwBzACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAGcAcgBvAHUAcABzACwAIABrAGUAeQBfAGMAbwBsAHUAbQBuAHMALAAgAGsAZQB5AHMALAAgAHMAYwBoAGUAbQBhAHMALAAgAHQAYQBiAGwAZQBzACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAXwBzAGMAaABlAG0AYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAdABlAHMAdAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABlAG4AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGcAYQBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB0AGgAZQBvAHMAcwBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAbwBzAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAdwBvAG0AYQBzAHMAIABzAGMAaABlAG0AYQAsACAAaQBjAHIAcwBjAG8AcgByACwAIABtAGEAaQBuACwAIABwAHAAbQB4AGwAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwAzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQByAGEAdAAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAbABhAHQAZQBjAG8AcgByAHMALAAgAHAAbABhAHQAZQBzACwAIABwAHAAbQB4AGMAcgBvAHMAcwAsACAAcwBwAHUAcgBpAG8AdQBzACwAIAB0AHcAbwBtAGEAcwBzAGMAcgBvAHMAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAcwBuAG8AYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdgBlAHIAbwBuAHEAcwBvAHMAIABzAGMAaABlAG0AYQAsACAAcwB0AHIAaQBwAGUAOAAyACAAZgByAG8AbQAgAHQAaABlACAAdgBsAGEAcwB0AHIAaQBwAGUAOAAyACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGQAcwBkAHMAcwAxADAAIABzAGMAaABlAG0AYQAsACAAYQByAGMAaABpAHYAZQBzACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdwBmAHAAZABiACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGkAcwBlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB4AHAAcABhAHIAYQBtAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHoAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAuAAAAN2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2luZm8AAAAQAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAAAATMjAwOS0xMi0wMVQxMDowMDowMAAAABMyMDI0LTAyLTA2VDEwOjE5OjMzAAAAAAAAAAAAAAAAAAAAAH/AAAAAAAAAAAABWGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvdGFwAAAA2Gl2bzovL2l2b2EubmV0L3N0ZC9kYWxpI2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3RhcAAAAHl2cjp3ZWJicm93c2VyOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAASDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAADw6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta new file mode 100644 index 0000000000000000000000000000000000000000..b28d76b4e46e18e8b674c1a29722f2a9cd382795 GIT binary patch literal 2962 zcmds3TW=ai6t)^1yCIF^My*sek?4aXI~x{QawAe6D8{)_AQ&gjLp2(92X^CScQZ2! zrc$KlrLCoXsk;3~edu54zv(x-3)rcYq<$SCZeGcst4qNo6RA z>02y*`d74OGios|;^+!zuR|uJ(1qloDMQW_wm}7Z>-R>>zFeBJ>Gd6zlo#s zL`a{rILe#8>oQY1z6YLsheIT@=CnQN-ISbqV#s)rdC={6qd3~^&vDHKZq2kq?~qyX z&k!#dpD>QYes;LFOB;{&ONL(4je?vyLNeweAfIdcS zT=;RL%UM9-$V|eL?fjTY+qdw}ZfCzAN9RKB#?e(<%HV#f#Mww6!C2krqmraSNz6Pm zwm-2~ld#$Ac78|2R-C*{-Q>y59bc;=@ceIf?7!EDtwr(jW zmJN8cJA(yYsj62hh{blx@xr4W<OzW#~?9GXV$&h7XZ1&m{*Tq9JF1w}i$ zXge0mj5I*@8Oj?)Oe}v)9S?}FGejndgdU2{89FM}q2bHy+7qX5j-$)Vn@rf#mFVgc zDVQXVhqggoXmee>>^S=T^nE}PB_)cPXgDO`zVy*d;LTO#6nxK3g;4RjOa?A0i&>fF zBHjUxx~@Mxfon%O;`!6~$!~xE$-;sC=uK=}84%?LzBP-#pRKN}^qS8On*03+mj5hd ze0IH6Z$Erc-+k7)4t($BgZ*Z!+30VT>(0b?tSzIVp&b&{B-B~hK9|I!;{-}>9O))N zmVm@%6XwqOEGA6u1gedsC^SN(5hF+^g)ljz=%hrj*9(v(TEjp!wA27+WJ{6Ur%h^U zjvsOeQwd6?A`mHJLftU4a0J!FAEMoiC{M&q>4Xiamz?oVO~Xsk&pBE%p`+23aj(&- zx0?HnCXT8y1ri`Ncgwh&{A)^=I#uiGKbUFHJDOm@0+Z5d^?hwAB6-6HRbo(i7HlP{ z`_H8Fgp7|<>UeUvaO;^=E+qU1h1^eb=j;lVgpX5*zCqqe$1|yYM^2)gx+r)H;{@G< zaYT5p*ZB?~&M^@~rIj85yix{Jr-sPfg=!yhA4A5qLs%LIhsiF>WnQ^kQi`~W#2VuqDu zObB>|LjxoEN;ZX85--=F{9&(i(AB>xK3(oZ(MoKGb|~Ywm@(vaY7mjmnE61q=d%SJ({ea=4*}d7Nk-#L4PMnN l86D%eN=(KT%etChM`{;HHmqoanAo1t)wAU}J`M+={tv=A8`A&) literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 3c75d2b3..c8aa731a 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -80,3 +80,29 @@ def test_servedby_elision(_servedby_elision_responses): assert d.obscore_recs[0].ivoid == "ivo://org.gavo.dc/tap" assert ('Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because it is served by ivo://org.gavo.dc/tap' in d.log_messages) + + +@pytest.fixture +def _access_url_elision_responses(requests_mock): + matcher = LearnableRequestMocker("access-url-elision") + requests_mock.add_matcher(matcher) + + +def test_access_url_elision(_access_url_elision_responses): + with pytest.warns(): + d = discover.ImageDiscoverer( + time=time.Time("1910-07-15", scale="utc"), + spectrum=400*u.nm) + d.set_services(registry.search(registry.Ivoid( + "ivo://org.gavo.dc/tap", + "ivo://org.gavo.dc/__system__/siap2/sitewide")), + # that's important here: we *want* to query the same stuff twice + purge_redundant=False) + d.query_services() + + # make sure we found anything at all + assert d.results + + # make sure there are no duplicate records + access_urls = [im.access_url for im in d.results] + assert len(access_urls) == len(set(access_urls)) From 06d7c9b7711189d1b72e291e06239ce96c820421 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 8 Feb 2024 15:21:15 +0100 Subject: [PATCH 14/38] Adding timeouts to global discovery --- pyvo/discover/image.py | 49 +++++++++++++----- ...i-heidelberg.de-siap2.xml-d4zedJmw9oczzciY | 17 ++++++ ...delberg.de-siap2.xml-d4zedJmw9oczzciY.meta | Bin 0 -> 1804 bytes 3 files changed, 54 insertions(+), 12 deletions(-) create mode 100644 pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY create mode 100644 pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 08716050..342181a9 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -12,6 +12,8 @@ import functools +import requests + from astropy import units as u from astropy import table from astropy import time @@ -28,6 +30,21 @@ from astropy.units.quantity import Quantity +# We should probably have a general way to set query timeouts in pyVO. +# For now, we don't, but for global discovery there's really no way +# around them. So, let me hack something here. + +class SessionWithTimeout(requests.Session): + def __init__(self, *args, default_timeout=None, **kwargs): + self.default_timeout = default_timeout + super().__init__(*args, **kwargs) + + def request(self, *args, **kwargs): + if "timeout" not in kwargs: + kwargs["timeout"] = self.default_timeout + return super().request(*args, **kwargs) + + class Queriable: """A facade for a queriable service. @@ -147,17 +164,20 @@ class ImageDiscoverer: # a radius as a float in degrees radius = None - def __init__(self, + def __init__(self, *, space=None, spectrum=None, time=None, inclusive=False, - watcher=None): + watcher=None, + timeout=20): + self.session = SessionWithTimeout(default_timeout=timeout) + if space: self.center = (space[0], space[1]) self.radius = space[2] - + # internally, a float in meters if spectrum is not None: self.spectrum = spectrum.to(u.m, equivalencies=u.spectral()).value - # a float in MJD + # internally, a float in MJD if time is not None: self.time = time.mjd @@ -355,8 +375,8 @@ def non_spatial_filter(sia1_rec): return True self._info("Querying SIA1 {}...".format(rec.title)) - svc = rec.res_rec.get_service("sia") - n_found = self.add_records( + svc = rec.res_rec.get_service("sia", session=self.session) + n_found = self._add_records( ImageFound.from_sia1_recs( svc.search( pos=self.center, size=self.radius, intersect='overlaps'), @@ -385,7 +405,7 @@ def _query_one_sia2(self, rec: Queriable): """ self._info("Querying SIA2 {}...".format(rec.title)) - svc = rec.res_rec.get_service("sia2") + svc = rec.res_rec.get_service("sia2", session=self.session) constraints = {} if self.center is not None: constraints["pos"] = self.center+(self.radius,) @@ -394,7 +414,7 @@ def _query_one_sia2(self, rec: Queriable): if self.time is not None: constraints["time"] = time.Time(self.time, format="mjd") - n_found = self.add_records( + n_found = self._add_records( ImageFound.from_obscore_recs(svc.search(**constraints))) self._log(f"SIA2 {rec.title}: {n_found} records") @@ -411,7 +431,7 @@ def _query_one_obscore(self, rec: Queriable, where_clause:str): """runs our query against a Obscore capability of rec. """ self._info("Querying Obscore {}...".format(rec.title)) - svc = rec.res_rec.get_service("tap") + svc = rec.res_rec.get_service("tap", session=self.session) n_found = self._add_records( ImageFound.from_obscore_recs( @@ -463,12 +483,13 @@ def query_services(self): self._query_sia1() -def images_globally( +def images_globally(*, space: Optional[Tuple[float, float, float]]=None, spectrum: Optional[Quantity]=None, time: Optional[float]=None, inclusive: bool=False, - watcher: Optional[Callable[[str], None]]=None + watcher: Optional[Callable[[str], None]]=None, + timeout: float=20 ) -> Tuple[List[obscore.ObsCoreMetadata], List[str]]: """returns a collection of ObsCoreMetadata-s matching certain constraints and a list of log lines. @@ -498,7 +519,11 @@ def images_globally( is excluded; this mimics the behaviour of SQL engines that consider comparisons with NULL-s false. """ - discoverer = ImageDiscoverer(space, spectrum, time, inclusive, watcher) + discoverer = ImageDiscoverer( + space=space, spectrum=spectrum, time=time, + inclusive=inclusive, + watcher=watcher, + timeout=timeout) discoverer.discover_services() discoverer.query_services() # TODO: We should un-dupe by image access URL diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY new file mode 100644 index 00000000..e894c1d6 --- /dev/null +++ b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY @@ -0,0 +1,17 @@ + +Definition and support code for the ObsCore data model and table.{'BAND0': 4.0000000000000003e-07, 'TIME0': 18867.0}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. +The calib_level flag takes the following values: + +=== =========================================================== + 0 Raw Instrumental data requiring instrument-specific tools + 1 Instrumental data processable with standard tools + 2 Calibrated, science-ready data without instrument signature + 3 Enhanced data products (e.g., mosaics) +=== ===========================================================High level scientific classification of the data product, taken from an enumerationAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.AAAABWltYWdlAAEAAAAWUG90c2RhbSBLYXB0ZXluIFNlcmllcwAAACRrYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHMAAAAxUG90c2RhbSBLYXB0ZXluIFNlcmllcyA5MSBmb3IgMDdBIEthcHRleW4tU3BlY2lhbAAAADhpdm86Ly9vcmcuZ2F2by5kYy9+P2thcHRleW4vZGF0YS9maXRzL1BPVDA4MF8wMDAwOTEuZml0cwAAAAAAAABxaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9rYXB0ZXluL3EvZGwvZGxtZXRhP0lEPWl2bzovL29yZy5nYXZvLmRjL34lM0ZrYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHMAAAAmYXBwbGljYXRpb24veC12b3RhYmxlO2NvbnRlbnQ9ZGF0YWxpbmsAAAAAAAAACgAAABMwN0EgS2FwdGV5bi1TcGVjaWFsAAAABlJlZ2lvbkByXBBNR47fQD11dhs2AEo/c5JtPxh6vQAAAH9Qb2x5Z29uIElDUlMgMjk0LjA1NjgwMjUyNCAyOS4xNjYxMzk1MDk3IDI5My40NTQzMjcwMzg1IDI5LjE1ODAxMjk4MjEgMjkzLjQ0NDA0NjIwNDcgMjkuNzUzNzI5MDA1MyAyOTQuMDU2MDg4MTI3MSAyOS43NTk1NjY2OTgxP2GdYmIxCMhA0mzAAAAAAEDSbMAAAAAAf8AAAH/AAAA+mYBZrJmmhT6hcsQXx3Hvf/gAAAAAAAAAAAAGZW0ub3B0AAAAAAAAAApBTyBQb3RzZGFtAAAAGEdyZWF0IFJlZnJhY3RvciAtIFBPVDA4MAAAAAAAAB9AAAAAAAAAG7z///////////////////////////////8/YZ1iYjEIyAAAAAAAAABcaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L2thcHRleW4vZGF0YS9maXRzL1BPVDA4MF8wMDAwOTEuZml0cz9wcmV2aWV3PVRydWU=
A datalink service accompanying obscore. This will forward to data +collection-specific datalink services if they exist or return +extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta new file mode 100644 index 0000000000000000000000000000000000000000..3992caa48419618acadfc84d4364b863f9e367f2 GIT binary patch literal 1804 zcmb7FQBNC35T=d67N#+THfq&Ix<*w60iTVb1gKC&F{KHLgNUm>Mcci*F?Zp7ce&le zI1*CxQWbUIy8TCe=)dS+>9_XT28BwkAACErGqbnzec#;Ag+JaaP7QvSdP$Xq_b+MTD-wEb+=s&84} zkz+OLjSXvUW2e5cv%YB^K5Lu!IX8|ZMY1aU3G(LlbF)1#KjBFd1}--jt6fyjW67P6 zRxY}s$z2@fdVxq{)1Npp9m`8JuX{h|QgYYt;;65!P7qSWyR`cdJPom$Ov?Kj-FvnZ(g6rhwt>8b5ejWN*&23^K#BH&2_ z|B`x$7@9U3_06|?t>*5AUBCHTr)vH2%I)qi+fSYy?5=HXZ9cZ^EBRCV@B7mO+W95F zylgl%n}Hxzeu|!IHT#1x_J+p&q>tM~)lmb$n8ud9WWqhV!l=$Vjk;q*@4O%v1BxYSEMp8G zbaUD?1wjucZnsihKI0{QFPJ9KU&~{hx9}6`a`X z>lR7_4Pho;34%>9Db19YBE*U0V7*!2sgQ_qW-z_%&Z0W1a$?SgsAJC%+ literal 0 HcmV?d00001 From e39dd8751a3f0d5f4a1badccb4b8af5602258f31 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 9 Feb 2024 09:59:57 +0100 Subject: [PATCH 15/38] Including utils.testing docs in the main doc --- docs/utils/index.rst | 20 ++++++++++++++------ docs/utils/testing.rst | 21 ++++++++++++++------- 2 files changed, 28 insertions(+), 13 deletions(-) diff --git a/docs/utils/index.rst b/docs/utils/index.rst index 7dcaa929..d8bc6d5a 100644 --- a/docs/utils/index.rst +++ b/docs/utils/index.rst @@ -1,12 +1,14 @@ .. _pyvo-utils: -*************************** -PyVO utils (``pyvo.utils``) -*************************** +***************************** +pyVO utilities (`pyvo.utils`) +***************************** - -This module contains utilities and base classes intended for internal use -within PyVO or other dependent libraries. +This subpackage collects a few packages intended to help developing +and maintaining pyVO. All of this is not part of pyVO's public API and +may change at any time. It is documented here for the convenience +of the maintainers and to help users when the effects of this code +becomes user-visible. Reference/API @@ -14,3 +16,9 @@ Reference/API .. automodapi:: pyvo.utils.xml.elements :no-inheritance-diagram: + +.. toctree:: + :maxdepth: 1 + + prototypes + testing diff --git a/docs/utils/testing.rst b/docs/utils/testing.rst index 54617d7b..447f2f1e 100644 --- a/docs/utils/testing.rst +++ b/docs/utils/testing.rst @@ -4,22 +4,24 @@ Helpers for Testing (`pyvo.utils.testing`) ****************************************** -This package contains a few helpers to make testing pyvo code simpler. -This is *not* intended to be used by user code or other libraries at +This package contains a few helpers to make testing pyVO code that does +a lot of network interaction simpler. +It is *not* intended to be used by user code or other libraries at this point; the API might change at any time depending on the testing needs of pyVO itself, and this documentation (mainly) addresses pyVO developers. The LearnableRequestMocker --------------------------- +========================== By its nature, much of pyVO is about talking to remote services. Talking to these remote services in order to test pyVO code makes test runs dependent on the status of external resources and may be slow. It is therefore desirable to “can” responses to a large extent, -i.e., use live responses to define the test fixture. This is what -`pyvo.utils.testing.LearnableRequestMocker` tries to support. +i.e., use live responses to define a test +fixture usable offline. This is what +`~pyvo.utils.testing.LearnableRequestMocker` tries to support. To use it, define a fixture for the mocker, somewhat like this:: @@ -43,8 +45,7 @@ request produces two files: All these must become part of the package for later tests to run without network interaction. The is intended to facilitate figuring out which response belongs to which request; it consists of the method, -the host, the start of the payload (if any), and hashes of the full URL -and a payload. +the host, and hashes of the full URL and a payload. When the upstream response (or whatever request pyvo produces) changes, remove the @@ -53,3 +54,9 @@ cached files and re-run test with ``--remote-data=any``. We do not yet have a good plan for how to preserve edits made to the test files. For now, commit the original responses, do any changes, and do a commit encompassing only these changes. + + +Reference/API +============= + +.. automodapi:: pyvo.utils.testing From f6ceb4054b8dad4afe81291b18d818711abadb99 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 9 Feb 2024 11:29:03 +0100 Subject: [PATCH 16/38] Adding some documentation on global dataset discovery. --- CHANGES.rst | 4 + docs/discover/index.rst | 186 ++++++++++++++++++++++++++++++++++++++++ docs/index.rst | 1 + pyvo/discover/image.py | 8 +- 4 files changed, 195 insertions(+), 4 deletions(-) create mode 100644 docs/discover/index.rst diff --git a/CHANGES.rst b/CHANGES.rst index 54cec15f..c451b3bc 100644 --- a/CHANGES.rst +++ b/CHANGES.rst @@ -57,6 +57,10 @@ Enhancements and Fixes and without obscore attributes [#599] +- New sub-package discover for global dataset discovery. [#470] + + + Deprecations and Removals ------------------------- diff --git a/docs/discover/index.rst b/docs/discover/index.rst new file mode 100644 index 00000000..7af21381 --- /dev/null +++ b/docs/discover/index.rst @@ -0,0 +1,186 @@ +.. _pyvo-discover: + +****************************************** +Global Dataset Discovery (`pyvo.discover`) +****************************************** + +One of the promises of the Virtual Observatory has always been that +researchers can globally look for data sets (spectra, say). In the +early days of the VO, this looked relatively simple: Just enumerate all +image (in those days: SIAP) services, send the same query to them, and +then somehow shoehorn together their responses. + +In reality, there are all kinds of small traps ranging from hanging +services to the sheer number of data collections. Hitting hundreds of +internet sites takes quite a bit of time even when everything works. In +the meantime, the picture is further complicated by the emergence of +additional protocols. Images, for instance, can be published through +SIA version 1, SIA version 2, and ObsTAP in 2024 – and in particular any +combination of that. + +To keep global discovery viable, several techniques can be applied: + +* pre-select the services by using the service footprints in space, + time, and spectrum. +* elide services serving the same data collections +* filter duplicate responses before presenting them to the user. + +This is the topic of this sub-module. + +In early 2024, this is still in early development. + + +Basic Usage +=========== + +The basic API for dataset discovery is through functions accepting +constraints on + +* space (currently, a cone, i.e., RA, Dec and a radius in degrees), +* spectrum (currently, a point in the spectrum as a spectral quantity), + and +* time (an astropy.time.Time instance or a pair of them to denote an + interval). + +For instance:: + + from pyvo import discover + from astropy import units as u + from astropy import time + + datasets, log = discover.images_globally( + space=(274.6880, -13.7920, 0.1), + spectrum=500.7*u.nm, + time=(time.Time('1995-01-01'), time.Time('1995-12-31'))) + +The function returns a pair of lists. ``datasets`` is a list of +`~pyvo.discover.image.ImageFound` instances. This is the (potentially +long) list of datasets located. + +The second returned value, ``log``, is a sequence of strings noting +which services failed and which returned how many records. In +exploratory work, it is probably all right to discard the information, +but for research purposes, these log lines are an important part of the +provenance and must be retained – after all, you might have missed an +important clue just because a service was down at the moment you ran +your discovery; also, you might want to re-query the failing services at +some later stage. + +The discovery function accepts a few other parameters you should know +about. These are discussed in the following sections. + + +``inclusive`` Searching +----------------------- + +Unfortunately, many resources in the VO do not yet declare their +coverage. In its default configuration, pyVO discovery will not query +services that do not explicitly say they cover the region of interest +and hence always skip these services (unless you manually pass them in, +see below). To change that behaviour and try services that do not state +their coverage, pass ``inclusive=True``. At this time, this will +usually dramatically increase the search time. + +Setting ``inclusive`` to True will also include datasets that do not +declare their temporal of spectral coverage when coming for version 1 +SIAP services [TODO: do that in obscore, too?]. This may +dramatically increase the number of false positives. It is probably +wise to only try ``inclusive=True`` when desperate or when there is a +particular necessity to not miss any potentially applicable data. + + +The Watcher +----------- + +Global discovery usually hits dozens of web services. To see what is +going on, you can pass in a function accepting a single string as +``watcher``. The trivial implementation would be:: + + import datetime + + def watch(msg): + print(datetime.datetime.now(), msg) + + found, log = discover.images_globally( + space=(3, 1, 0.2), watcher=watch) + + +Setting Timeouts +---------------- + +There are always some services that are broken. A particularly +insidious sort of brokenness occurs when data centres run reverse +proxies (many do these days) that are up and try to connect to a backend +server intended to run the actual service. In certain configurations, +it might take the reverse proxy literally forever to notice when a +backend server is unreachable, and meanwhile your global discovery will +hang, too. + +Therefore, pyVO global discovery will give up after ``timeout`` seconds, +defaulting to 20 seconds. Note that large data collections *may* take +longer than that to produce their response; but given the simple +constraints we support so far, we would probably consider them broken in +that case. Reducing the timeout to just a few seconds will make pyVO +continue earlier on broken services. But that of course increases the +risk of cutting off working services. + +If in doubt, have a brief look at the log lines; if a service that +sounds promising shows a timeout, perhaps try again with a longer +timeout or use partial matching. + + +Overriding service selection +---------------------------- + +You can also pass a `pyvo.registry.RegistryResults` instance to +``services`` to override the automatic selection of services to query. +See the discussion of overriding the service selection in Discoverers_. + + +Discoverers +=========== + +For finer control of the discovery process, you can directly use +the `pyvo.discover.image.ImageDiscoverer` class. It is constructed with +essentially the same parameters as the search function. + +To run the discovery, first establish which services to query. There +are two ways to do that: + +* Call the ``discover_services()`` method. This is what the search + function does; it uses your constraints as above. +* Pass a `pyvo.registry.RegistryResults` instance to ``set_services``. + This lets you do your own searches. The image discoverer will only + use resources that it knows how to handle. For instance, it is safe + to call something like:: + + discoverer.set_services( + registry.search(registry.Author("Hubble, %"))) + + to query services that give a particular author. More realistically, + + :: + + discoverer.set_services( + registry.search(registry.Datamodel("obscore"))) + + will restrict the operation to obscore services. + +``set_services`` will purge redundant services, which means that +services that say they (or their data) is served by another service that +will already be queried will not be queried. Outside of debugging, this +is what you want, but if you really do not want this, you can pass +``purge_redundant=False``. Note, however, that you will still get only +one match per access URL of the dataset. + +Once you have set the services, call ``query_services()`` to fill the +``results`` and ``log`` attributes. It may be informative to watch +these change from, say, a different thread. Changing their content has +undefined results. + + + +Reference/API +============= + +.. automodapi:: pyvo.discover.image diff --git a/docs/index.rst b/docs/index.rst index 72ffd39e..43d168bc 100644 --- a/docs/index.rst +++ b/docs/index.rst @@ -132,6 +132,7 @@ Using ``pyvo`` dal/index registry/index + discover/index io/index auth/index samp diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 342181a9..bdcd5fcb 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -17,7 +17,6 @@ from astropy import units as u from astropy import table from astropy import time -from astropy.coordinates import SkyCoord from ..dam import obscore from .. import dal @@ -27,7 +26,8 @@ # imports for type hints from typing import Callable, Generator, List, Optional, Set, Tuple -from astropy.units.quantity import Quantity +from astropy import time +from astropy.units import quantity # We should probably have a general way to set query timeouts in pyVO. @@ -485,8 +485,8 @@ def query_services(self): def images_globally(*, space: Optional[Tuple[float, float, float]]=None, - spectrum: Optional[Quantity]=None, - time: Optional[float]=None, + spectrum: Optional[quantity.Quantity]=None, + time: Optional[time.Time]=None, inclusive: bool=False, watcher: Optional[Callable[[str], None]]=None, timeout: float=20 From c65d073ee13964312660ff03843783e83ed1edba Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 9 Feb 2024 11:38:06 +0100 Subject: [PATCH 17/38] You can now pass a result of registry.search to discover.image_globally. --- pyvo/discover/image.py | 13 +++++++++++-- pyvo/discover/tests/test_imagediscovery.py | 11 +++++------ 2 files changed, 16 insertions(+), 8 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index bdcd5fcb..cfd73940 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -489,7 +489,8 @@ def images_globally(*, time: Optional[time.Time]=None, inclusive: bool=False, watcher: Optional[Callable[[str], None]]=None, - timeout: float=20 + timeout: float=20, + services: Optional[registry.RegistryResults]=None ) -> Tuple[List[obscore.ObsCoreMetadata], List[str]]: """returns a collection of ObsCoreMetadata-s matching certain constraints and a list of log lines. @@ -514,6 +515,9 @@ def images_globally(*, watcher : A callable that will be called with strings perhaps suitable for displaying to a human. + services : + An optional `~pyvo.registry.RegistryResults` instance to + override automatic services detection. When an image has insufficient metadata to evaluate a constraint, it is excluded; this mimics the behaviour of SQL engines that consider @@ -524,7 +528,12 @@ def images_globally(*, inclusive=inclusive, watcher=watcher, timeout=timeout) - discoverer.discover_services() + + if services is None: + discoverer.discover_services() + else: + discoverer.set_services(services) + discoverer.query_services() # TODO: We should un-dupe by image access URL # TODO: We could compute SODA cutout URLs here in addition. diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index c8aa731a..be76268d 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -28,13 +28,12 @@ def test_no_services_selected(): def test_single_sia1(_sia1_responses): - sia_svc = registry.search(registry.Ivoid("ivo://org.gavo.dc/bgds/q/sia")) - discoverer = image.ImageDiscoverer( + results, log = discover.images_globally( space=(116, -29, 0.1), - time=time.Time(56383.105520834, format="mjd")) - discoverer.set_services(sia_svc) - discoverer.query_services() - im = discoverer.results[0] + time=time.Time(56383.105520834, format="mjd"), + services=registry.search( + registry.Ivoid("ivo://org.gavo.dc/bgds/q/sia"))) + im = results[0] assert im.s_xel1 == 10800. assert isinstance(im.em_min, float) assert abs(im.s_dec+29)<2 From e194f844bc8d8fb7d7f2c677686ed218af084bca Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 12 Feb 2024 13:40:39 +0100 Subject: [PATCH 18/38] global discovery: the time constraint can now be an interval, too. --- docs/discover/index.rst | 5 + pyvo/discover/image.py | 53 +++++--- ...i-heidelberg.de-siap2.xml-d4zedJmw9oczzciY | 2 +- ...delberg.de-siap2.xml-d4zedJmw9oczzciY.meta | Bin 1804 -> 1804 bytes ...ah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R | 17 --- ...i-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta | Bin 1814 -> 0 bytes ...h.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S} | 2 +- ...i-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta | Bin 0 -> 1831 bytes ...i-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta | Bin 1814 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg | 2 +- ...ST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta | Bin 2962 -> 2962 bytes pyvo/discover/tests/test_imagediscovery.py | 128 ++++++++++++++++++ 12 files changed, 172 insertions(+), 37 deletions(-) delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta rename pyvo/discover/tests/data/access-url-elision/{POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo => POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S} (94%) create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta diff --git a/docs/discover/index.rst b/docs/discover/index.rst index 7af21381..dc232254 100644 --- a/docs/discover/index.rst +++ b/docs/discover/index.rst @@ -66,6 +66,11 @@ important clue just because a service was down at the moment you ran your discovery; also, you might want to re-query the failing services at some later stage. +All constraints are optional, but without a space constraint, no SIA1 +services will be queried. With spectrum and time constraints, it is +probably wise to pass ``inclusive=True`` for the time being, as far too +many resources do not define their coverage. + The discovery function accepts a few other parameters you should know about. These are discussed in the following sections. diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index cfd73940..2a4a6f7a 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -95,6 +95,9 @@ def __init__(self, obscore_record): @classmethod def from_obscore_recs(cls, obscore_result): + if not obscore_result: + return + ap_table = obscore_result.to_table() our_keys = [n for n in ap_table.colnames if n in cls.attr_names] for row in obscore_result: @@ -157,8 +160,8 @@ class ImageDiscoverer: # Constraint defaults # a float in metres spectrum = None - # an MJD float - time = None + # MJD floats + time_min = time_max = None # a center as a 2-tuple in ICRS degrees center = None # a radius as a float in degrees @@ -174,12 +177,15 @@ def __init__(self, *, if space: self.center = (space[0], space[1]) self.radius = space[2] - # internally, a float in meters + if spectrum is not None: self.spectrum = spectrum.to(u.m, equivalencies=u.spectral()).value - # internally, a float in MJD + if time is not None: - self.time = time.mjd + if isinstance(time, tuple): + self.time_min, self.time_max = time[0].mjd, time[1].mjd + else: + self.time_min = self.time_max = time.mjd self.inclusive = inclusive self.results: List[obscore.ObsCoreMetadata] = [] @@ -290,9 +296,11 @@ def discover_services(self): constraints.append( registry.Spectral(self.spectrum*u.m, inclusive=self.inclusive)) - if self.time is not None: + if self.time_min is not None or self.time_max is not None: constraints.append( - registry.Temporal(self.time, inclusive=self.inclusive)) + registry.Temporal( + (self.time_min, self.time_max), + inclusive=self.inclusive)) self.sia1_recs = [Queriable(r) for r in registry.search( registry.Servicetype("sia"), *constraints)] @@ -367,10 +375,14 @@ def non_spatial_filter(sia1_rec): return False # Regrettably, the exposure time is not part of SIA1 standard - # metadata. TODO: require time to be an interval and - # then replace check for dateobs to be within that interval. - if self.time and not self.inclusive and sia1_rec.dateobs: - if not self.time-1={self.spectrum})") - if self.time is not None: - where_parts.append(f"(t_min<={self.time} AND t_max>={self.time})") + + if self.time_min is not None or self.time_max is not None: + where_parts.append( + "({h1}>={l2} AND {h2}>={l1}" + " AND {l1}<={h1} AND {l2}<={h2})".format( + l1="t_min", h1="t_max", + l2=self.time_min, h2=self.time_max)) where_clause = "WHERE "+(" AND ".join(where_parts)) diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY index e894c1d6..3a15e2bf 100644 --- a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY +++ b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY @@ -1,5 +1,5 @@ -Definition and support code for the ObsCore data model and table.{'BAND0': 4.0000000000000003e-07, 'TIME0': 18867.0}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +Definition and support code for the ObsCore data model and table.{'BAND0': 4.0000000000000003e-07, 'TIME0': 18867.0}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for datasets within this datacenter. The calib_level flag takes the following values: diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta index 3992caa48419618acadfc84d4364b863f9e367f2..c938e1f2f30223fc0888b41f57e16786bf6ad9b0 100644 GIT binary patch delta 58 zcmeC->*1U5Pr^4pPe;MfNWm>NNx{g#$OOo?GBvX@*eu2<#3GO;dMdRvDZ{09N=AYg Lkh9r>^$H^Z@^=xX delta 58 zcmeC->*1U5Pa-6vR7b(ULcuLHNx{g#$V9==#LB?L%6PLFqY#Tg$^9d#rAZkswNo+@ Mynvj|7OYno0SeI*Qvd(} diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R deleted file mode 100644 index a9e7cc7d..00000000 --- a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R +++ /dev/null @@ -1,17 +0,0 @@ - -Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. -The calib_level flag takes the following values: - -=== =========================================================== - 0 Raw Instrumental data requiring instrument-specific tools - 1 Instrumental data processable with standard tools - 2 Calibrated, science-ready data without instrument signature - 3 Enhanced data products (e.g., mosaics) -=== ===========================================================High level scientific classification of the data product, taken from an enumerationData product specific typeAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.Name of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.
A datalink service accompanying obscore. This will forward to data -collection-specific datalink services if they exist or return -extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKGKNJHT7R.meta deleted file mode 100644 index 237462aad0d34b0f8e54793b6a9b4904fa91fd6a..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1814 zcmaJ?&2HO95H@PraxFKuW3*_|22c+Q?8u@d%JCoIgJ7v~6IYgHr9ltDVo8of#w3^F zE-fj5f#y=wz}~ujg1$-*eT69O9fO_$d%(_4wh`EwmF}zKH3vO@`C$>mp(B4zZ;m43e$UWiRK*O_z`a|u!SGP(o z6E0W`O6F|l`(O)?g_x7Oh_NI%)7TEacT>bP5aPSNu&?B1cj{}-d|BH~!fSBU zZ&;o~d;>9VuF}n;20cByDx1cUVdlla;{u#lV3o~^Q8Ow!C*x3o7s@oo%cHKF?B*+n z`5(Z_n-y~}U#%V2j*j;Z^3Q(i>i9LAg#toR5~B$7)=pEiJ2tsA0 zKCZW8h$uEPtuRkp4nVlf!S8HeTy>RPOk!WjZC8lsxLkH@;~jO4B=kxycv#DVxNkU6 z7BnjJQD`goGk0kWp}XSdb~HY#2{yY#``8L4S6^zQJ~0lW(a#su zS*z*DPm|#L`y?0)2BjX0gA(?9%;hmzH5pcLs@S!s$7W*&=FGL3qR3CjLC2Au0&<@om13Uv?)S-an5hf}~4z`4e2gIGQe z893?9x!OS=^?f$@z}J!)60(7M{@1^MLt?pSx5{-=LuM@IV7ve8G%sH^uev7=yG$S+ zJwC6uo}JVim*`4WkCLxQ)73e0A3BG>fP>6ff(bW)iI; zg<7Lv9(Vx`6RyR2tAXi<5RkwN3$;@`-ZLuqpBj`ZlSmy#hlN`6qhST}Xj)UuOI8mL z_YaNA_ypb45~&+=bQh6$T$L+MDT;jFmKlwel3#yJgp~Yzu0wJ`xrv(y^&Y_`Zzq={ z!V7?*vo!@3MbhzN#DSwPOU9fWX~yIKCk7hec8S;!>y#BuoS`1Vv9if^V&fl-%zj|% IF0m5hf5mIAF8}}l diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S similarity index 94% rename from pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo rename to pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S index 919491c2..76869d90 100644 --- a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo +++ b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S @@ -1,5 +1,5 @@ -Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for +Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for datasets within this datacenter. The calib_level flag takes the following values: diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta new file mode 100644 index 0000000000000000000000000000000000000000..fe80f0c328cc64a941763532130c3093d0c6ff7d GIT binary patch literal 1831 zcmaJ?-%lGy5T?aoifMq*rmdPt?t>$U@!6ayU?d(a?1lznz!0T*h*o=dYwp6`?&Wq5 z+mVo(m#Rqn*6sgP^{?ve{jkGBdM~>(J2N{w-^_Qv7yf=+oJqc0wJu9sU=ed9uPw6y*ki^Mt`*827h%n^?64eNWyFGfPrQk<+l}cpanv6Wo|EW? zM6kKYHcvYE@aUp$8ZE;ti=oE_ab6RvZZ?dj(a=5x2Mb83&`FjjFB#n|Z<*y^h*dTl z<~Hp2x10OTo$~XSm)d^GW>gR=YGNFM-_l_wUMAuXI1GKy#`r_0)O?6*`O9Xq*>tT`r)B;c_0p2ml)&>bQIskq|>6 zvj|hS`G5$QIq=T2(~CB_71GNOWa5q%Lq+=VNLs z_e*y!fzVxWOB))W#TbfR!&guWB^O_5p`8kk!ZF-MYk7K5eRI#)(#2cGwoO9u38c&I zR5Jy1_3DEcZk8P~@Bxy|vK491`P36OsRKOWS^b$lSp-06+Dae*98=+%kg$e*=t6Dy zAVOw4ou`)hYWD+i`45ZHOuA;+Jh3oZ490HC$!qY zHd{MCt2-D~*lsmi2y-;C=*cA)z|N91!R%`oWEfZEumF1$6hCH)EE0+-jF&g?bW_6( zkFsOR@1NYsmFY#J$fH0I*oWJEA6|ARAKpI?F@U5)5gVulg%J}BXalM_ zr;7sX?2vPf*9x+Hm?7e1nRB%PI_&#w_=&D33y89zdNF$VFNrPp=vKK-Cdh)toU!`t zyDw&D`rY$a-HXcuhn>eH8b3X0_nsfLJLe})LEnFKz=>wAYQ=0<2N4UZ-VMVBv$ze+ zR(*Zc?RTrdDH!r~fEAJEiAu9mF?YQH#s$`DyVn8tJrbb6qm||%9B&(q`(KmP8mXl= z!=p;G`&qM!*~(*zsqNO@-p;PkNKUeS8U$=Sny8aqnn2=s-&W_9JDM$BcIZ^Dd3*t= zJ_PC}>aF7P0n){Tmeq{UsOrVK_X8|!7s$9LO9(~-0Wk@VV7Nf=J<9+Y{AKA(uYJOy zr(porWkG|hdHhY@2Edw*7XfS>@+qRE ri^qCK;D;0u9Kd!C*(4Hhyr5fcq{lX)I=PH&_@$xAA5GoGR&4wSHAt@o literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKoMkZ0hPo.meta deleted file mode 100644 index d6cf0c9dfe89e837c78ed225530e1f6b9210acd8..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1814 zcmaJ?&2HO95H@PraxFKuW3*_|22c+Q?8u@d%JCoIgJ7v~6IYgHr9ltDVo8of#w3^F zE-fj5f#y=wz}~ujqXO+K^bz_Nos}plJ|w*C&g{%^Io~%Qf6e@v%Px$cTeU57Tu_m4 zVlxNSi+^O+1?oV|mE4NqZ30|ygNrz^MG}Mdo>C4!h8#lf3GW6Po-NcLYUjPWRdShd z!D3J{XEWaiTX-zQoZLl>CBd1-cJRHMBBmklL0p0m-|dBcB{#cMUvuWm+HMkFgQI@K z@*LtDh;eh3ZXPx0>Dg7;G>!~2F9seL;JgB>Y*vh#QPDXWhYGwnM25!q0G7DUv7BB+D#>YOc zw_}JXHZrX+Pg@Q^xXi)tY+qb;m0V0>U&(D(i0HUnc5LGvb&VwSN-lU<%YwLXI8YWe zD)UijEB7;ZX$+ye;^uZVKC1~fyF~lg3ME%xYNI|e4x-V|7v-w4j}>le`^CO(^?Hu^ z)Nph|D<*cgJ;K|B<(g5gA}-tKUYHDbba&UOZ9^nJzBvu$;QRX|7z_rb9*ct#_I%9cFOCp9m z8{r)_hQ=i64Ti|A2J~p+i%C{{5|$1i@+SnrZHmJDcax7ErKp`6Sj zT5`=rHl&v{G3*PRbew16uz-3YI=)REX(f_`IDcNx)2zoge3c%D{Qk+E+?b!F#a=AP z@8(Vpf_Nb+2=(!8zK>saCm-HFk0^qqOM#8rL!y`ohPr~?T+&U!b#cJC#%qIEJ`Nc; z>CL&?K_B&fHu%8Tk{J@RfqMS;zkfkuxo5Y^by7oSEaqUl|LZg_UpBA0Cl0$zARawF zueY9^)Ek%QkI~=x<%EOQwPL}n7ke=airx*Q2D7-0x>tO4*6cKks5lfa>!4;5ts;e5 zqhKC*0S*(c#d@oO>4y-IzzYktQ#{@?D)*lnlq!=*9Y%+RTJxh}1@mZHQ_M?N4-fYb zjLP@~-P01O8*_9Qk$7C|_6kaSgi;Oawc_#t(Y-(hYK3Q^Y9*S=0Ts53;@grrf=nkU zM1m8X6*PR$GSJ3+nQQB{0~{%eeBPEBjg^vLe@ujw{CuuMazVL?n+WwD!6k1emm|Up zfT6QB1r9>TG*$#r7mAB@a?VCpWh G661dYrmklI diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg index 84858f8d..0c2ffca6 100644 --- a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg +++ b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg @@ -14,7 +14,7 @@ NATURAL LEFT OUTER JOIN rr.alt_identifier WHERE (ivoid='ivo://org.gavo.dc/tap' OR ivoid='ivo://org.gavo.dc/__system__/siap2/sitewide') GROUP BY -ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
+ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband, alt_identifier">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta index b28d76b4e46e18e8b674c1a29722f2a9cd382795..f8fc0da63e8e66c46c82584ebd3b6eb0f9727277 100644 GIT binary patch delta 86 zcmbOvK1qDSKS|&GJRJo?BL%nABn2Y_BNHIo%EZ{p*le>nqc)?ciIH}?QF3xxs)?aq l3P|3-$k1qWIMYHVfeN8hsijF79<@_4QoMki%^a*B&iHX(>jg ndMO}z10w^A&EZT7nFJ=@Jd#?Pl;Kf3B_qWP$l1)n+QkL{FasLM diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index be76268d..555d0cc3 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -3,8 +3,11 @@ Tests for pyvo.discover.image """ +import weakref + import pytest +from astropy import coordinates from astropy import time from astropy import units as u @@ -15,6 +18,130 @@ from pyvo.utils.testing import LearnableRequestMocker +class FakeQueriable: + """a scaffolding class to record queries built by the various + discovery methods. + + It's a stand-in for all of discover.Queriable, the resource record, + and the services. All query functions just make their search + arguments available in search_args and search_kwargs attributes here + and otherwise return whatever you pass in as return_this. + """ + def __init__(self, return_this=[]): + self.title = "Fake scaffold service" + self.ivoid = "ivo://x-invalid/pyvo-fake" + self.return_this = return_this + self.res_rec = weakref.proxy(self) + + def get_service(self, service_type, **kwargs): + return self + + def search(self, *args, **kwargs): + self.search_args = args + self.search_kwargs = kwargs + return self.return_this + + run_sync = search + + +class FakeSIARec: + """a convenience class to halfway easily create SIA1 records + sufficient for testing. + """ + defaults = { + "bandpass_lolimit": 5e-7*u.m, + "bandpass_hilimit": 7e-7*u.m, + "dateobs": time.Time("1970-10-13T14:00:00"), + "filesize": 20, + "naxis": (10*u.pix, 20*u.pix), + "naxes": 2, + "pos": coordinates.SkyCoord(0*u.deg, 0*u.deg)} + + def __init__(self, **kwargs): + for key, value in self.defaults.items(): + setattr(self, key, value) + for key, value in kwargs.items(): + setattr(self, key, value) + + def __getattr__(self, name): + return None + + +class TestTimeCondition: + def test_sia1(self): + # this primarily tests for local filtering + queriable = FakeQueriable([ + FakeSIARec(), FakeSIARec(dateobs=time.Time("1970-10-14"))]) + d = discover.ImageDiscoverer( + space=(0, 0, 1), + time=( + time.Time("1970-10-13T13:00:00"), + time.Time("1970-10-13T17:00:00"))) + d._query_one_sia1(queriable) + assert len(d.results) == 1 + assert abs(d.results[0].t_min-40872.583333333336)<1e-10 + assert queriable.search_kwargs == { + 'pos': (0, 0), 'size': 1, 'intersect': 'overlaps'} + + def test_sia1_nointerval(self): + queriable = FakeQueriable([ + FakeSIARec(), FakeSIARec(dateobs=time.Time("1970-10-14"))]) + d = discover.ImageDiscoverer( + space=(0, 0, 1), + time=time.Time("1970-10-13T13:00:02")) + d._query_one_sia1(queriable) + assert len(d.results) == 1 + + def test_sia2(self): + queriable = FakeQueriable() + d = discover.ImageDiscoverer( + time=( + time.Time("1970-10-13T13:00:00"), + time.Time("1970-10-13T17:00:00"))) + d._query_one_sia2(queriable) + + assert set(queriable.search_kwargs) == set(["time"]) + assert abs(queriable.search_kwargs["time" + ][0].utc.value-40872.54166667)<1e-8 + + def test_sia2_nointerval(self): + queriable = FakeQueriable() + d = discover.ImageDiscoverer( + time=time.Time("1970-10-13T13:00:00")) + d._query_one_sia2(queriable) + + assert set(queriable.search_kwargs) == set(["time"]) + assert abs(queriable.search_kwargs["time" + ][0].utc.value-40872.54166667)<1e-8 + assert abs(queriable.search_kwargs["time" + ][1].utc.value-40872.54166667)<1e-8 + + def test_obscore(self): + queriable = FakeQueriable() + d = discover.ImageDiscoverer( + time=( + time.Time("1970-10-13T13:00:00"), + time.Time("1970-10-13T17:00:00"))) + d.obscore_recs = [queriable] + d._query_obscore() + + assert set(queriable.search_kwargs) == set() + assert queriable.search_args[0] == ( + "select * from ivoa.obscore WHERE dataproduct_type='image' AND (t_max>=40872.541666666664 AND 40872.708333333336>=t_min AND t_min<=t_max AND 40872.541666666664<=40872.708333333336)") + + def test_obscore_nointerval(self): + queriable = FakeQueriable() + d = discover.ImageDiscoverer( + time=( + time.Time("1970-10-13T13:00:00"))) + d.obscore_recs = [queriable] + d._query_obscore() + + assert set(queriable.search_kwargs) == set() + assert queriable.search_args[0] == ( + "select * from ivoa.obscore WHERE dataproduct_type='image' AND (t_max>=40872.541666666664 AND 40872.541666666664>=t_min AND t_min<=t_max AND 40872.541666666664<=40872.541666666664)") + + @pytest.fixture def _sia1_responses(requests_mock): matcher = LearnableRequestMocker("sia1-responses") @@ -101,6 +228,7 @@ def test_access_url_elision(_access_url_elision_responses): # make sure we found anything at all assert d.results + assert len([1 for l in d.log_messages if "skipped" in l]) == 0 # make sure there are no duplicate records access_urls = [im.access_url for im in d.results] From 347034ead4a21b5a48533cb975fd01d13ad57e5b Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 15 Feb 2024 14:52:13 +0100 Subject: [PATCH 19/38] Adding a method for service stats to the discoverer --- pyvo/discover/image.py | 12 ++++++++++++ 1 file changed, 12 insertions(+) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 2a4a6f7a..4b112fc7 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -188,6 +188,7 @@ def __init__(self, *, self.time_min = self.time_max = time.mjd self.inclusive = inclusive + self.already_queried = 0 self.results: List[obscore.ObsCoreMetadata] = [] self.watcher = watcher self.log_messages: List[str] = [] @@ -411,6 +412,7 @@ def _query_sia1(self): self._query_one_sia1(rec) except Exception as msg: self._log(f"SIA1 {rec.ivoid} skipped: {msg}") + self.already_queried += 1 def _query_one_sia2(self, rec: Queriable): """runs our query against a SIA2 capability of rec. @@ -440,6 +442,7 @@ def _query_sia2(self): self._query_one_sia2(rec) except Exception as msg: self._log(f"SIA2 {rec.ivoid} skipped: {msg}") + self.already_queried += 1 def _query_one_obscore(self, rec: Queriable, where_clause:str): """runs our query against a Obscore capability of rec. @@ -484,6 +487,15 @@ def _query_obscore(self): except Exception as msg: self._log("Obscore {} skipped: {}".format( rec.res_rec['ivoid'], msg)) + self.already_queried += 1 + + def get_query_stats(self): + """returns a tuple of |total to query|, |already queried| + """ + total_to_query = len(self.obscore_recs + ) + len(self.sia1_recs + ) + len(self.sia2_recs) + return total_to_query, self.already_queried def query_services(self): """queries the discovered image services according to our From 641d2a9d8145a9d17eed9579c709338fe14a0617 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Wed, 21 Feb 2024 14:24:06 +0100 Subject: [PATCH 20/38] Adding basic cancelability to global discovery. Basically, you can now clear the queue of services to query. Once the currently running query finishes, that will also end query_services. I've thought about canceling the currently running query, too, but that seems to be hard. --- pyvo/discover/image.py | 76 +++++++++++++++++++++++++++++------------- 1 file changed, 52 insertions(+), 24 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 4b112fc7..2ecd918f 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -11,6 +11,7 @@ """ import functools +import threading import requests @@ -126,7 +127,7 @@ def from_sia1_recs(cls, sia1_result, filter_func): "s_ra": rec.pos.icrs.ra.to(u.deg).value, "s_dec": rec.pos.icrs.dec.to(u.deg).value, "obs_title": rec.title, - # TODO: do more (s_resgion!) on the basis of the WCS parts + # TODO: do more (s_region!) on the basis of the WCS parts } yield cls(mapped) @@ -188,13 +189,17 @@ def __init__(self, *, self.time_min = self.time_max = time.mjd self.inclusive = inclusive - self.already_queried = 0 + self.already_queried, self.failed_services = 0, 0 self.results: List[obscore.ObsCoreMetadata] = [] self.watcher = watcher self.log_messages: List[str] = [] - self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] self.known_access_urls: Set[str] = set() + self._service_list_lock = threading.Lock() + with self._service_list_lock: + # only write to these while holding the lock + self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] + def _info(self, message: str) -> None: """sends message to our watcher (if there is any) """ @@ -303,13 +308,20 @@ def discover_services(self): (self.time_min, self.time_max), inclusive=self.inclusive)) - self.sia1_recs = [Queriable(r) for r in registry.search( - registry.Servicetype("sia"), *constraints)] - self.sia2_recs = [Queriable(r) for r in registry.search( - registry.Servicetype("sia2"), *constraints)] - self.obscore_recs = self._discover_obscore_services(*constraints) + with self._service_list_lock: + self.sia1_recs = [Queriable(r) for r in registry.search( + registry.Servicetype("sia"), *constraints)] + self._info("Found {} SIA1 service(s)".format(len(self.sia1_recs))) + + self.sia2_recs = [Queriable(r) for r in registry.search( + registry.Servicetype("sia2"), *constraints)] + self._info("Found {} SIA2 service(s)".format(len(self.sia2_recs))) + + self.obscore_recs = self._discover_obscore_services(*constraints) + self._info("Found {} Obscore service(s)".format( + len(self.obscore_recs))) - self._purge_redundant_services() + self._purge_redundant_services() def set_services(self, registry_results: registry.RegistryResults, @@ -325,20 +337,33 @@ def set_services(self, that are already called. There are very few situations in which you would want to do that, mostly related to debugging. """ - for rsc in registry_results: - if "tap" in rsc.access_modes(): - # TODO: we ought to ensure there's an obscore - # table on this; but by the time this sees users, - # I hope to have fixed obscore discovery. - self.obscore_recs.append(Queriable(rsc)) - elif "sia2" in rsc.access_modes(): - self.sia2_recs.append(Queriable(rsc)) - elif "sia" in rsc.access_modes(): - self.sia1_recs.append(Queriable(rsc)) - # else ignore this record - - if purge_redundant: - self._purge_redundant_services() + with self._service_list_lock: + for rsc in registry_results: + if "tap" in rsc.access_modes(): + # TODO: we ought to ensure there's an obscore + # table on this; but by the time this sees users, + # I hope to have fixed obscore discovery. + self.obscore_recs.append(Queriable(rsc)) + elif "sia2" in rsc.access_modes(): + self.sia2_recs.append(Queriable(rsc)) + elif "sia" in rsc.access_modes(): + self.sia1_recs.append(Queriable(rsc)) + # else ignore this record + + if purge_redundant: + self._purge_redundant_services() + + def reset_services(self): + """clears the queues of services to query. + + This is the only supported way to interrupt operations once + query_services has been called. + + This will not interrupt the query currently running. There is + currently no way to do that. + """ + with self._service_list_lock: + self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] def _add_records(self, recgen: Generator[ImageFound, None, None]) -> int: @@ -412,6 +437,7 @@ def _query_sia1(self): self._query_one_sia1(rec) except Exception as msg: self._log(f"SIA1 {rec.ivoid} skipped: {msg}") + self.failed_services += 1 self.already_queried += 1 def _query_one_sia2(self, rec: Queriable): @@ -442,6 +468,7 @@ def _query_sia2(self): self._query_one_sia2(rec) except Exception as msg: self._log(f"SIA2 {rec.ivoid} skipped: {msg}") + self.failed_services += 1 self.already_queried += 1 def _query_one_obscore(self, rec: Queriable, where_clause:str): @@ -487,6 +514,7 @@ def _query_obscore(self): except Exception as msg: self._log("Obscore {} skipped: {}".format( rec.res_rec['ivoid'], msg)) + self.failed_services += 1 self.already_queried += 1 def get_query_stats(self): @@ -495,7 +523,7 @@ def get_query_stats(self): total_to_query = len(self.obscore_recs ) + len(self.sia1_recs ) + len(self.sia2_recs) - return total_to_query, self.already_queried + return total_to_query, self.already_queried, self.failed_services def query_services(self): """queries the discovered image services according to our From 554d334f8a7bba9b73d150abe3ed5e40127a89ab Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 22 Feb 2024 09:44:09 +0100 Subject: [PATCH 21/38] Global discovery records now record the service of origin. --- pyvo/discover/image.py | 56 ++++++++++++++++++++++++++++-------------- 1 file changed, 38 insertions(+), 18 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 2ecd918f..68c3addb 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -10,6 +10,16 @@ The code here looks for data in SIA1, SIA2, and Obscore services for now. """ +# TODOs: +# * Evaluate and log Overflow conditions in the three protocols +# * do more (s_region!) on the basis of the WCS parts in SIA1 +# * In obscore, we probably should make the dataproduct type constraint +# configurable (this should really also work for cubes) +# * Obscore query generation *might* want some extra logic for inclusive, +# (as in OR whatever IS NULL) -- but is that a good idea? +# * It would be nice if we preserved datalink availability and perhaps +# even let people do automatic cutouts to the RoI. + import functools import threading @@ -77,17 +87,19 @@ def obscore_column_names(): class ImageFound(obscore.ObsCoreMetadata): """Obscore metadata for a found record. - We're pulling these out from the various VOTables that we + The mandatory obscore fields are kept as attributes. + + We are pulling these out from the various VOTables that we retrieve because we need to do some manipulation of them - that's simpler to do if they are proper Python objects. + that is simpler to do if they are proper Python objects. - This is an implementation detail, though; eventually, we're - turning these into an astropy table and further into a VOTable - to make this as compatible with the DAL services as possible. + This also keeps track of the service the record came from, + which is available from the origin_service attribute. """ attr_names = set(obscore_column_names()) - def __init__(self, obscore_record): + def __init__(self, origin_service, obscore_record): + self.origin_service = origin_service for k, v in obscore_record.items(): if k not in self.attr_names: raise TypeError( @@ -95,17 +107,19 @@ def __init__(self, obscore_record): setattr(self, k, v) @classmethod - def from_obscore_recs(cls, obscore_result): + def from_obscore_recs(cls, origin_service, obscore_result): if not obscore_result: return ap_table = obscore_result.to_table() our_keys = [n for n in ap_table.colnames if n in cls.attr_names] for row in obscore_result: - yield cls(dict(zip(our_keys, (row[n] for n in our_keys)))) + yield cls( + origin_service, + dict(zip(our_keys, (row[n] for n in our_keys)))) @classmethod - def from_sia1_recs(cls, sia1_result, filter_func): + def from_sia1_recs(cls, origin_service, sia1_result, filter_func): for rec in sia1_result: if not filter_func(rec): continue @@ -127,9 +141,8 @@ def from_sia1_recs(cls, sia1_result, filter_func): "s_ra": rec.pos.icrs.ra.to(u.deg).value, "s_dec": rec.pos.icrs.dec.to(u.deg).value, "obs_title": rec.title, - # TODO: do more (s_region!) on the basis of the WCS parts } - yield cls(mapped) + yield cls(origin_service, mapped) def _clean_for(records: List[Queriable], ivoids_to_remove: Set[str]): @@ -416,6 +429,7 @@ def non_spatial_filter(sia1_rec): svc = rec.res_rec.get_service("sia", session=self.session) n_found = self._add_records( ImageFound.from_sia1_recs( + rec.ivoid, svc.search( pos=self.center, size=self.radius, intersect='overlaps'), non_spatial_filter)) @@ -457,7 +471,9 @@ def _query_one_sia2(self, rec: Queriable): time.Time(self.time_max, format="mjd")) n_found = self._add_records( - ImageFound.from_obscore_recs(svc.search(**constraints))) + ImageFound.from_obscore_recs( + rec.ivoid, + svc.search(**constraints))) self._log(f"SIA2 {rec.title}: {n_found} records") def _query_sia2(self): @@ -479,16 +495,14 @@ def _query_one_obscore(self, rec: Queriable, where_clause:str): n_found = self._add_records( ImageFound.from_obscore_recs( + rec.ivoid, svc.run_sync("select * from ivoa.obscore "+where_clause))) self._log(f"Obscore {rec.title}: {n_found} records") def _query_obscore(self): """runs the Obscore part of our discovery. """ - # TODO: we probably should make the dataproduct type constraint - # configurable. where_parts = ["dataproduct_type='image'"] - # TODO: we'd need extra logic for inclusive here, too if self.center is not None: where_parts.append( "(distance(s_ra, s_dec, {}, {}) < {}".format( @@ -529,7 +543,7 @@ def query_services(self): """queries the discovered image services according to our constraints. - This creates fills the results and the log attributes. + This creates and fills the results and the log attributes. """ if (not self.sia1_recs and not self.sia2_recs @@ -581,6 +595,14 @@ def images_globally(*, When an image has insufficient metadata to evaluate a constraint, it is excluded; this mimics the behaviour of SQL engines that consider comparisons with NULL-s false. + + Returns + ------- + discovered_images, log_lines + The images found are returned in a list of `ImageFound` instances. + log_lines is a list of strings reporting which services were + queried with which result (and possibly more). So far, this + is not considered machine-readable. """ discoverer = ImageDiscoverer( space=space, spectrum=spectrum, time=time, @@ -594,6 +616,4 @@ def images_globally(*, discoverer.set_services(services) discoverer.query_services() - # TODO: We should un-dupe by image access URL - # TODO: We could compute SODA cutout URLs here in addition. return discoverer.results, discoverer.log_messages From 0e5b7af4adca494f5d849036a38555c8faac95ad Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 23 Feb 2024 10:42:16 +0100 Subject: [PATCH 22/38] Global discovery: Downgrading obscore query to ADQL 2.0 Also, fixing a crash in relationship discovery when there are no records to discover relationships for. --- pyvo/discover/image.py | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 68c3addb..bab7ff8e 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -250,6 +250,8 @@ def ids(recs): | ids(self.obscore_recs))), description="ivoids of candiate services", meta={"ucd": "meta.ref.ivoid"}),]) + if len(ids_present) == 0: + return services_for = regtap.get_RegTAP_service().run_sync( """SELECT ivoid, related_id @@ -505,7 +507,8 @@ def _query_obscore(self): where_parts = ["dataproduct_type='image'"] if self.center is not None: where_parts.append( - "(distance(s_ra, s_dec, {}, {}) < {}".format( + "(1=contains(point('ICRS', s_ra, s_dec)," + " circle('ICRS', {}, {}, {}))".format( self.center[0], self.center[1], self.radius) +" or 1=intersects(circle({}, {}, {}), s_region))".format( self.center[0], self.center[1], self.radius)) From 40e9a4e53528d75805aef51d75da2570e89edfe8 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 23 Feb 2024 10:49:08 +0100 Subject: [PATCH 23/38] global discovery: get_service is now lax. This is relevant when, for one reason or other, multiple capabilities of a type are present in a registry record. For our purposes here (sia, ssap, tap...), it is highly unlikely that these different capabilities correspond to different data (that's as different from VizieR SCS, where different capabilities correspond to different tables; but that's a pain and we don't want anything like that here). --- pyvo/discover/image.py | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index bab7ff8e..901534eb 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -428,7 +428,7 @@ def non_spatial_filter(sia1_rec): return True self._info("Querying SIA1 {}...".format(rec.title)) - svc = rec.res_rec.get_service("sia", session=self.session) + svc = rec.res_rec.get_service("sia", session=self.session, lax=True) n_found = self._add_records( ImageFound.from_sia1_recs( rec.ivoid, @@ -461,7 +461,7 @@ def _query_one_sia2(self, rec: Queriable): """ self._info("Querying SIA2 {}...".format(rec.title)) - svc = rec.res_rec.get_service("sia2", session=self.session) + svc = rec.res_rec.get_service("sia2", session=self.session, lax=True) constraints = {} if self.center is not None: constraints["pos"] = self.center+(self.radius,) @@ -493,7 +493,7 @@ def _query_one_obscore(self, rec: Queriable, where_clause:str): """runs our query against a Obscore capability of rec. """ self._info("Querying Obscore {}...".format(rec.title)) - svc = rec.res_rec.get_service("tap", session=self.session) + svc = rec.res_rec.get_service("tap", session=self.session, lax=True) n_found = self._add_records( ImageFound.from_obscore_recs( From 5aa642775f957a32219aaf0681620690d79532d5 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 23 Feb 2024 11:07:58 +0100 Subject: [PATCH 24/38] SIA1: warding against NULL-s in the bandpass definition SIA1 has all the various bandpass definitions optional (whether we like it or not). This commit makes our result construction resilient against services that don't provide it. --- pyvo/dal/sia.py | 17 ++++++++++------- 1 file changed, 10 insertions(+), 7 deletions(-) diff --git a/pyvo/dal/sia.py b/pyvo/dal/sia.py index 602207bb..d600666d 100644 --- a/pyvo/dal/sia.py +++ b/pyvo/dal/sia.py @@ -706,7 +706,7 @@ def instr(self): @property def dateobs(self): """ - the modified Julien date (MJD) of the mid-point of the + the modified Julian date (MJD) of the mid-point of the observational data that went into the image, as an astropy.time.Time instance """ @@ -821,24 +821,27 @@ def bandpass_refvalue(self): the characteristic (reference) wavelength, frequency or energy for the bandpass model, as an astropy Quantity of bandpass_unit """ - return Quantity( - self.getbyucd("VOX:BandPass_RefValue"), self.bandpass_unit) + value = self.getbyucd("VOX:BandPass_RefValue") + if value is not None and self.bandpass_unit: + return Quantity(val, self.bandpass_unit) @property def bandpass_hilimit(self): """ the upper limit of the bandpass as astropy Quantity in bandpass_unit """ - return Quantity( - self.getbyucd("VOX:BandPass_HiLimit"), self.bandpass_unit) + value = self.getbyucd("VOX:BandPass_HiLimit") + if value is not None and self.bandpass_unit: + return Quantity(value, self.bandpass_unit) @property def bandpass_lolimit(self): """ the lower limit of the bandpass as astropy Quantity in bandpass_unit """ - return Quantity( - self.getbyucd("VOX:BandPass_LoLimit"), self.bandpass_unit) + value = self.getbyucd("VOX:BandPass_LoLimit") + if value is not None and self.bandpass_unit: + return Quantity(value, self.bandpass_unit) # Processig Metadata @property From bd0ce9ae057ddd1a736c92af1a14d04d5f0e93fb Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 23 Feb 2024 11:13:06 +0100 Subject: [PATCH 25/38] global discovery: not requiring optional SIA1 fields any more Also, we're sneaking in a change in SIA1 bandpass behaviour: We now accept the standard strings for bandpass units and assume m if the bandpass declaration is missing (that's against the standard, but in line with acutal practice). --- pyvo/dal/sia.py | 25 ++++++++++++++++++------- pyvo/discover/image.py | 17 ++++++++++------- 2 files changed, 28 insertions(+), 14 deletions(-) diff --git a/pyvo/dal/sia.py b/pyvo/dal/sia.py index d600666d..0def083a 100644 --- a/pyvo/dal/sia.py +++ b/pyvo/dal/sia.py @@ -807,13 +807,24 @@ def bandpass_unit(self): """ the astropy unit used to represent spectral values. """ - sia = self.getbyucd("VOX:BandPass_Unit", decode=True) - - if sia: - return Unit(sia) - else: - # dimensionless - return Unit("") + sia_unit = self.getbyucd("VOX:BandPass_Unit", decode=True) + + # the standard says this should be `"meters", "hertz", and "keV"', + # which in practice everyone has ignored. Still, let's + # translate the standard terms. Somewhat more dangerously, + # we replace a missing unit with metres; in theory, we should + # reject anything but the three terms above, but then 99% + # of SIA services would break. And without the assumption of + # a metre default, 20% of 2024 SIA1 services would have unusable + # bandpasses. + + astropy_unit = { + None: "m", + "": "m", + "meters": "m", + "hertz": "Hz"}.get(sia_unit, sia_unit) + + return Unit(astropy_unit) @property def bandpass_refvalue(self): diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 901534eb..3a19c588 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -126,14 +126,17 @@ def from_sia1_recs(cls, origin_service, sia1_result, filter_func): mapped = { "dataproduct_type": "image" if rec.naxes == 2 else "cube", "access_url": rec.acref, - "em_max": rec.bandpass_hilimit is not None - and rec.bandpass_hilimit.to(u.m).value, - "em_min": rec.bandpass_lolimit is not None - and rec.bandpass_lolimit.to(u.m).value, + "em_max": None if rec.bandpass_hilimit is None + else rec.bandpass_hilimit.to(u.m).value, + "em_min": None if rec.bandpass_lolimit is None + else rec.bandpass_lolimit.to(u.m).value, # Sigh. Try to guess exposure time? - "t_min": rec.dateobs.mjd, - "t_max": rec.dateobs.mjd, - "access_estsize": rec.filesize/1024, + "t_min": None if rec.dateobs is None + else rec.dateobs.mjd, + "t_max": None if rec.dateobs is None + else rec.dateobs.mjd, + "access_estsize": None if rec.filesize is None + else rec.filesize/1024, "access_format": rec.format, "instrument_name": rec.instr, "s_xel1": rec.naxis[0].to(u.pix).value, From 997c549ca6d916cc8721fd14ed0ac57f3921380b Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 26 Feb 2024 10:35:12 +0100 Subject: [PATCH 26/38] Updating global discovery test cases. This is mainly about using 1=contains rather than distance in the obscore queries; we also had to update the RegTAP capability.xml in the registry test to bring it in line with what the discover tests do. A better isolation of these test suites would be desirable; but then we don't want forsake capabilities caching altogether either... Also, sneaking in a few formatting problems. --- pyvo/dal/sia.py | 2 +- pyvo/discover/image.py | 5 +- ...i-heidelberg.de-siap2.xml-d4zedJmw9oczzciY | 4 +- ...delberg.de-siap2.xml-d4zedJmw9oczzciY.meta | Bin 1804 -> 1804 bytes ...ah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S | 4 +- ...i-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta | Bin 1831 -> 1831 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg | 23 -- .../POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E | 23 ++ ...T-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta} | Bin 2962 -> 2916 bytes ...ET-reg.g-vo.org-capabilities-VYcr5usI.meta | Bin 1504 -> 1504 bytes .../GET-reg.g-vo.org-tables-Mffx+yRe.meta | Bin 1431 -> 1431 bytes ...h.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO} | 4 +- ...i-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta | Bin 0 -> 1910 bytes ...i-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta | Bin 1888 -> 0 bytes ...> POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C} | 12 +- ...ST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta | Bin 0 -> 3241 bytes ...ST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta | Bin 3250 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU | 2 +- ...ST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta | Bin 3249 -> 3249 bytes ...> POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ} | 12 +- ...ST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta | Bin 0 -> 3107 bytes ...> POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm} | 15 +- ...T-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta} | Bin 3163 -> 3204 bytes ...> POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl} | 15 +- ...T-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta} | Bin 3153 -> 3117 bytes ...ST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta | Bin 3287 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill | 2 +- ...ST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta | Bin 3161 -> 3161 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg | 23 -- .../POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E | 23 ++ ...T-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta} | Bin 2962 -> 2916 bytes ...ni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk | 6 +- ...idelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta | Bin 1759 -> 1727 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi | 23 -- .../POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB | 23 ++ ...T-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta} | Bin 2900 -> 2854 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl | 2 +- ...ST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta | Bin 3088 -> 3088 bytes pyvo/registry/tests/data/capabilities.xml | 247 ++++++++++++------ pyvo/registry/tests/test_regtap.py | 19 +- 40 files changed, 282 insertions(+), 207 deletions(-) delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg create mode 100644 pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E rename pyvo/discover/tests/data/access-url-elision/{POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta => POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta} (58%) rename pyvo/discover/tests/data/image-with-all-constraints/{POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 => POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO} (94%) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr => POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C} (57%) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD => POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ} (51%) create mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ => POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm} (53%) rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta => POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta} (52%) rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS => POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl} (54%) rename pyvo/discover/tests/data/image-with-all-constraints/{POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta => POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta} (54%) delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta delete mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg create mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E rename pyvo/discover/tests/data/servedby-elision-responses/{POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta => POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta} (56%) delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi create mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB rename pyvo/discover/tests/data/sia1-responses/{POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta => POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta} (59%) diff --git a/pyvo/dal/sia.py b/pyvo/dal/sia.py index 0def083a..faf4945d 100644 --- a/pyvo/dal/sia.py +++ b/pyvo/dal/sia.py @@ -834,7 +834,7 @@ def bandpass_refvalue(self): """ value = self.getbyucd("VOX:BandPass_RefValue") if value is not None and self.bandpass_unit: - return Quantity(val, self.bandpass_unit) + return Quantity(value, self.bandpass_unit) @property def bandpass_hilimit(self): diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 3a19c588..fe6d8fa1 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -37,7 +37,6 @@ # imports for type hints from typing import Callable, Generator, List, Optional, Set, Tuple -from astropy import time from astropy.units import quantity @@ -291,7 +290,7 @@ def _discover_obscore_services(self, *constraints): new_style_access_urls = set() for rec in obscore_services: new_style_access_urls |= set( - i.baseurl for i in rec.list_services("tap")) + i.access_url for i in rec.list_interfaces("tap")) for tap_rec in tap_services_with_obscore: access_urls = set( @@ -492,7 +491,7 @@ def _query_sia2(self): self.failed_services += 1 self.already_queried += 1 - def _query_one_obscore(self, rec: Queriable, where_clause:str): + def _query_one_obscore(self, rec: Queriable, where_clause: str): """runs our query against a Obscore capability of rec. """ self._info("Querying Obscore {}...".format(rec.title)) diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY index 3a15e2bf..2a00c4b7 100644 --- a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY +++ b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY @@ -1,6 +1,6 @@ -Definition and support code for the ObsCore data model and table.{'BAND0': 4.0000000000000003e-07, 'TIME0': 18867.0}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. +Definition and support code for the ObsCore data model and table.{'BAND0': 4.0000000000000003e-07, 'TIME0': 18867.0}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. The calib_level flag takes the following values: === =========================================================== diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta index c938e1f2f30223fc0888b41f57e16786bf6ad9b0..366156c5fa0cad318d907cd1ef1745cdaea6abb2 100644 GIT binary patch delta 55 zcmeC->*3qL%qU`Hrr?&Eq+n!VWTIeTX=Q9=WoofmoKcWP;8fI|)Y7C3m)a>A30^?X JW((FUi~yE)5eWbQ delta 55 zcmeC->*3qL%qU`Lq~MmCq+n!VWTIebWMyh*Wni{hoKcWPAWigCYH3o2OYM}51TP?G JvjyuFMgV|X4~GB% diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S index 76869d90..5cbe02c8 100644 --- a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S +++ b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S @@ -1,6 +1,6 @@ -Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. +Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. The calib_level flag takes the following values: === =========================================================== diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta index fe80f0c328cc64a941763532130c3093d0c6ff7d..bb04edabf323f7f4a7da2b7eb36a93d4dbb117f8 100644 GIT binary patch delta 63 zcmZ3^x14VSGoyr&nSxttl7f+ek%@wVrIoRfm8pe-yKl(k|4d4oZ5fv`3!I9&lUkaT S;ZZv!BgG5I+5CyclnDSpN)+7y delta 63 zcmZ3^x14VSGoyr|k%C)ll7f+ek%@w#k(G(Dm9d$EyKl(k|4d4oZ5fv`3seZ5N-a&w S@Ti@Vk>Um9Z2rVz$^-x_Srd2w diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg deleted file mode 100644 index 0c2ffca6..00000000 --- a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg +++ /dev/null @@ -1,23 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
-The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAAAAAAFWl2bzovL29yZy5nYXZvLmRjL3RhcAAAABF2czpjYXRhbG9nc2VydmljZQAAAAtHQVZPIERDIFRBUAAAABwARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAgAFQAQQBQACAAcwBlAHIAdgBpAGMAZQAAAAAAABQZAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABUAEEAUAAgAGUAbgBkACAAcABvAGkAbgB0AC4AIAAgAAoAVABoAGUAIABUAGEAYgBsAGUAIABBAGMAYwBlAHMAcwAgAFAAcgBvAHQAbwBjAG8AbAAgACgAVABBAFAAKQAgAGwAZQB0AHMAIAB5AG8AdQAgAGUAeABlAGMAdQB0AGUAIABxAHUAZQByAGkAZQBzACAAYQBnAGEAaQBuAHMAdAAgAG8AdQByAAoAZABhAHQAYQBiAGEAcwBlACAAdABhAGIAbABlAHMALAAgAGkAbgBzAHAAZQBjAHQAIAB2AGEAcgBpAG8AdQBzACAAbQBlAHQAYQBkAGEAdABhACwAIABhAG4AZAAgAHUAcABsAG8AYQBkACAAeQBvAHUAcgAgAG8AdwBuAAoAZABhAHQAYQAuACAAIAAKAAoASQBuACAARwBBAFYATwAnAHMAIABkAGEAdABhACAAYwBlAG4AdABlAHIALAAgAHcAZQAgAGkAbgAgAHAAYQByAHQAaQBjAHUAbABhAHIAIABoAG8AbABkACAAcwBlAHYAZQByAGEAbAAgAGwAYQByAGcAZQAKAGMAYQB0AGEAbABvAGcAcwAgAGwAaQBrAGUAIABQAFAATQBYAEwALAAgADIATQBBAFMAUwAgAFAAUwBDACwAIABVAFMATgBPAC0AQgAyACwAIABVAEMAQQBDADQALAAgAFcASQBTAEUALAAgAFMARABTAFMAIABEAFIAMQA2ACwACgBIAFMATwBZACwAIABhAG4AZAAgAHMAZQB2AGUAcgBhAGwAIABHAGEAaQBhACAAZABhAHQAYQAgAHIAZQBsAGUAYQBzAGUAcwAgAGEAbgBkACAAYQBuAGMAaQBsAGwAYQByAHkAIAByAGUAcwBvAHUAcgBjAGUAcwAgAGYAbwByAAoAeQBvAHUAIAB0AG8AIAB1AHMAZQAgAGkAbgAgAGMAcgBvAHMAcwBtAGEAdABjAGgAZQBzACwAIABwAG8AcwBzAGkAYgBsAHkAIAB3AGkAdABoACAAdQBwAGwAbwBhAGQAZQBkACAAdABhAGIAbABlAHMALgAKAAoAVABhAGIAbABlAHMAIABlAHgAcABvAHMAZQBkACAAdABoAHIAbwB1AGcAaAAgAHQAaABpAHMAIABlAG4AZABwAG8AaQBuAHQAIABpAG4AYwBsAHUAZABlADoAIABuAHUAYwBhAG4AZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbQBhAG4AZABhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAG4AbgBpAHMAcgBlAGQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAMQAwACAAcwBjAGgAZQBtAGEALAAgAGQAcgAxADAAIABmAHIAbwBtACAAdABoAGUAIABhAHAAYQBzAHMAIABzAGMAaABlAG0AYQAsACAAZgByAGEAbQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABhAHAAbwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQBwAHAAbABhAHUAcwBlACAAcwBjAGgAZQBtAGEALAAgAGcAZgBoACwAIABpAGQALAAgAGkAZABlAG4AdABpAGYAaQBlAGQALAAgAG0AYQBzAHQAZQByACwAIABuAGkAZAAsACAAdQBuAGkAZABlAG4AdABpAGYAaQBlAGQAIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBnAGYAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQByAGkAaABpAHAAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAdQBnAGUAcgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABwAGgAbwB0AF8AYQBsAGwALAAgAHMAcwBhAF8AdABpAG0AZQBfAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAYgBnAGQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYgBvAHkAZABlAG4AZABlACAAcwBjAGgAZQBtAGEALAAgAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYgByAG8AdwBuAGQAdwBhAHIAZgBzACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAZgBsAHUAeABwAG8AcwB2ADEAMgAwADAALAAgAGYAbAB1AHgAcABvAHMAdgA1ADAAMAAsACAAZgBsAHUAeAB2ADEAMgAwADAALAAgAGYAbAB1AHgAdgA1ADAAMAAsACAAbwBiAGoAZQBjAHQAcwAsACAAcwBwAGUAYwB0AHIAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBsAGkAZgBhAGQAcgAzACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABzAHIAYwBjAGEAdAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAIABzAGMAaABlAG0AYQAsACAAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAYQByAGMAcwAgAHMAYwBoAGUAbQBhACwAIABsAGkAbgBlAF8AdABhAHAAIABmAHIAbwBtACAAdABoAGUAIABjAGEAcwBhAF8AbABpAG4AZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1AHUAcABkAGEAdABlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAHMAOAAyAG0AbwByAHAAaABvAHoAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AIABmAHIAbwBtACAAdABoAGUAIABjAHMAdABsACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABkAGEAbgBpAHMAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBwAGwAYQB0AGUAcwAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBfAHMAcABlAGMAdAByAGEALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAG0AdQBiAGkAbgAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZQBtAGkAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABmAGsANgBqAG8AaQBuACwAIABwAGEAcgB0ADEALAAgAHAAYQByAHQAMwAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAawA2ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQByAGUAXwBzAHUAcgB2AGUAeQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABvAHIAZABlAHIAcwBtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBsAGEAcwBoAGgAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBvAHIAbgBhAHgAIABzAGMAaABlAG0AYQAsACAAZAByADIAXwB0AHMAXwBzAHMAYQAsACAAZAByADIAZQBwAG8AYwBoAGYAbAB1AHgALAAgAGQAcgAyAGwAaQBnAGgAdAAsACAAZAByADMAbABpAHQAZQAsACAAZQBkAHIAMwBsAGkAdABlACAAZgByAG8AbQAgAHQAaABlACAAZwBhAGkAYQAgAHMAYwBoAGUAbQBhACwAIABoAHkAYQBjAG8AYgAsACAAbQBhAGcAbABpAG0AcwA1ACwAIABtAGEAZwBsAGkAbQBzADYALAAgAG0AYQBnAGwAaQBtAHMANwAsACAAbQBhAGkAbgAsACAAbQBpAHMAcwBpAG4AZwBfADEAMABtAGEAcwAsACAAcgBlAGoAZQBjAHQAZQBkACwAIAByAGUAcwBvAGwAdgBlAGQAcwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBjAG4AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZwBjAHAAbQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGEAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMgBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHAAaABvAHQAbwBtAGUAdAByAHkAIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAsACAAdwBpAHQAaABwAG8AcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADMAcwBwAGUAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAGEAdQB0AG8AIABzAGMAaABlAG0AYQAsACAAbABpAHQAZQB3AGkAdABoAGQAaQBzAHQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAZABpAHMAdAAgAHMAYwBoAGUAbQBhACwAIABnAGUAbgBlAHIAYQB0AGUAZABfAGQAYQB0AGEALAAgAG0AYQBnAGwAaQBtAF8ANQAsACAAbQBhAGcAbABpAG0AXwA2ACwAIABtAGEAZwBsAGkAbQBfADcALAAgAG0AYQBpAG4ALAAgAHAAYQByAHMAZQBjAF8AcAByAG8AcABzACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBzAHAAdQByACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAHMAZQByAHYAaQBjAGUAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGwAbwB0AHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAcABzADEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAZABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABoAGkAaQBjAG8AdQBuAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAGkAcABwAGEAcgBjAG8AcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABwAHAAdQBuAGkAbwBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHMAbwB5ACAAcwBjAGgAZQBtAGEALAAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAaQBjAGUAYwB1AGIAZQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAaQBuAGYAbABpAGcAaAB0ACAAcwBjAGgAZQBtAGEALAAgAG8AYgBzAF8AcgBhAGQAaQBvACwAIABvAGIAcwBjAG8AcgBlACAAZgByAG8AbQAgAHQAaABlACAAaQB2AG8AYQAgAHMAYwBoAGUAbQBhACwAIABlAHYAZQBuAHQAcwAsACAAcABoAG8AdABwAG8AaQBuAHQAcwAsACAAdABpAG0AZQBzAGUAcgBpAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAMgBjADkAdgBzAHQAIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMAIABmAHIAbwBtACAAdABoAGUAIABrAGEAcAB0AGUAeQBuACAAcwBjAGgAZQBtAGEALAAgAGsAYQB0AGsAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAawBhAHQAawBhAHQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADUAIABzAGMAaABlAG0AYQAsACAAcwBzAGEAXwBsAHIAcwAsACAAcwBzAGEAXwBtAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADYAIABzAGMAaABlAG0AYQAsACAAZABpAHMAawBfAGIAYQBzAGkAYwAsACAAaABfAGwAaQBuAGsALAAgAGkAZABlAG4AdAAsACAAbQBlAHMAXwBiAGkAbgBhAHIAeQAsACAAbQBlAHMAXwBtAGEAcwBzAF8AcABsACwAIABtAGUAcwBfAG0AYQBzAHMAXwBzAHQALAAgAG0AZQBzAF8AcgBhAGQAaQB1AHMAXwBzAHQALAAgAG0AZQBzAF8AcwBlAHAAXwBhAG4AZwAsACAAbQBlAHMAXwB0AGUAZgBmAF8AcwB0ACwAIABvAGIAagBlAGMAdAAsACAAcABsAGEAbgBlAHQAXwBiAGEAcwBpAGMALAAgAHAAcgBvAHYAaQBkAGUAcgAsACAAcwBvAHUAcgBjAGUALAAgAHMAdABhAHIAXwBiAGEAcwBpAGMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZgBlAF8AdABkACAAcwBjAGgAZQBtAGEALAAgAGcAZQBvAGMAbwB1AG4AdABzACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwB0AGEAdABpAG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAGcAaAB0AG0AZQB0AGUAcgAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQB2AGUAcgBwAG8AbwBsACAAcwBjAGgAZQBtAGEALAAgAHIAbQB0AGEAYgBsAGUALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABsAG8AdABzAHMAcABvAGwAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwBwAG0AIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMALAAgAHcAbwBsAGYAcABhAGwAaQBzAGEAIABmAHIAbwBtACAAdABoAGUAIABsAHMAdwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbQBhAGcAaQBjACAAcwBjAGgAZQBtAGEALAAgAHIAZQBkAHUAYwBlAGQAIABmAHIAbwBtACAAdABoAGUAIABtAGEAaQBkAGEAbgBhAGsAIABzAGMAaABlAG0AYQAsACAAZQB4AHQAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYwBlAHgAdABpAG4AYwB0ACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAcwBsAGkAdABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAbQBsAHEAcwBvACAAcwBjAGgAZQBtAGEALAAgAGUAcABuAF8AYwBvAHIAZQAsACAAbQBwAGMAbwByAGIAIABmAHIAbwBtACAAdABoAGUAIABtAHAAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIABzAHQAYQByAHMAIABmAHIAbwBtACAAdABoAGUAIABtAHcAcwBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAZQAxADQAYQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbwBiAHMAYwBvAGQAZQAgAHMAYwBoAGUAbQBhACwAIABiAGkAYgByAGUAZgBzACwAIABtAGEAcABzACwAIABtAGEAcwBlAHIAcwAsACAAbQBvAG4AaQB0AG8AcgAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AaABtAGEAcwBlAHIAIABzAGMAaABlAG0AYQAsACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAbwBuAGUAYgBpAGcAYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABzAGgAYQBwAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AcABlAG4AbgBnAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAYwBjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAHQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABvAGwAYwBhAHQAcwBtAGMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABtAGEAcABzACAAZgByAG8AbQAgAHQAaABlACAAcABwAGEAawBtADMAMQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABwAG0AeAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIAB1AHMAbgBvAGMAbwByAHIAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4AGwAIABzAGMAaABlAG0AYQAsACAAbQBhAHAAMQAwACwAIABtAGEAcAA2ACwAIABtAGEAcAA3ACwAIABtAGEAcAA4ACwAIABtAGEAcAA5ACwAIABtAGEAcABfAHUAbgBpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcgBkAHUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGQAcgAyACwAIABkAHIAMwAsACAAZAByADQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAByAGEAdgBlACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABwAGgAbwB0AG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAcgBvAHMAYQB0ACAAcwBjAGgAZQBtAGEALAAgAGEAbAB0AF8AaQBkAGUAbgB0AGkAZgBpAGUAcgAsACAAYQB1AHQAaABvAHIAaQB0AGkAZQBzACwAIABjAGEAcABhAGIAaQBsAGkAdAB5ACwAIABnAF8AbgB1AG0AXwBzAHQAYQB0ACwAIABpAG4AdABlAHIAZgBhAGMAZQAsACAAaQBuAHQAZgBfAHAAYQByAGEAbQAsACAAcgBlAGcAaQBzAHQAcgBpAGUAcwAsACAAcgBlAGwAYQB0AGkAbwBuAHMAaABpAHAALAAgAHIAZQBzAF8AZABhAHQAZQAsACAAcgBlAHMAXwBkAGUAdABhAGkAbAAsACAAcgBlAHMAXwByAG8AbABlACwAIAByAGUAcwBfAHMAYwBoAGUAbQBhACwAIAByAGUAcwBfAHMAdQBiAGoAZQBjAHQALAAgAHIAZQBzAF8AdABhAGIAbABlACwAIAByAGUAcwBvAHUAcgBjAGUALAAgAHMAdABjAF8AcwBwAGEAdABpAGEAbAAsACAAcwB0AGMAXwBzAHAAZQBjAHQAcgBhAGwALAAgAHMAdABjAF8AdABlAG0AcABvAHIAYQBsACwAIABzAHUAYgBqAGUAYwB0AF8AdQBhAHQALAAgAHQAYQBiAGwAZQBfAGMAbwBsAHUAbQBuACwAIAB0AGEAcABfAHQAYQBiAGwAZQAsACAAdgBhAGwAaQBkAGEAdABpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAcgAgAHMAYwBoAGUAbQBhACwAIABvAGIAagBlAGMAdABzACwAIABwAGgAbwB0AHAAYQByACAAZgByAG8AbQAgAHQAaABlACAAcwBhAHMAbQBpAHIAYQBsAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHMAZABzAHMAZAByADEANgAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIANwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBtAGEAawBjAGUAZAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAGUAYwBpAGUAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAG0ANAAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwB1AHAAZQByAGMAbwBzAG0AbwBzACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAGcAcgBvAHUAcABzACwAIABrAGUAeQBfAGMAbwBsAHUAbQBuAHMALAAgAGsAZQB5AHMALAAgAHMAYwBoAGUAbQBhAHMALAAgAHQAYQBiAGwAZQBzACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAXwBzAGMAaABlAG0AYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAdABlAHMAdAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABlAG4AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGcAYQBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB0AGgAZQBvAHMAcwBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAbwBzAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAdwBvAG0AYQBzAHMAIABzAGMAaABlAG0AYQAsACAAaQBjAHIAcwBjAG8AcgByACwAIABtAGEAaQBuACwAIABwAHAAbQB4AGwAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwAzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQByAGEAdAAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAbABhAHQAZQBjAG8AcgByAHMALAAgAHAAbABhAHQAZQBzACwAIABwAHAAbQB4AGMAcgBvAHMAcwAsACAAcwBwAHUAcgBpAG8AdQBzACwAIAB0AHcAbwBtAGEAcwBzAGMAcgBvAHMAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAcwBuAG8AYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdgBlAHIAbwBuAHEAcwBvAHMAIABzAGMAaABlAG0AYQAsACAAcwB0AHIAaQBwAGUAOAAyACAAZgByAG8AbQAgAHQAaABlACAAdgBsAGEAcwB0AHIAaQBwAGUAOAAyACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGQAcwBkAHMAcwAxADAAIABzAGMAaABlAG0AYQAsACAAYQByAGMAaABpAHYAZQBzACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdwBmAHAAZABiACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGkAcwBlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB4AHAAcABhAHIAYQBtAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHoAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAuAAAAN2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2luZm8AAAAQAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAAAATMjAwOS0xMi0wMVQxMDowMDowMAAAABMyMDI0LTAyLTA2VDEwOjE5OjMzAAAAAAAAAAAAAAAAAAAAAH/AAAAAAAAAAAABWGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvdGFwAAAA2Gl2bzovL2l2b2EubmV0L3N0ZC9kYWxpI2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3RhcAAAAHl2cjp3ZWJicm93c2VyOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAASDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAADw6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E new file mode 100644 index 00000000..067a5236 --- /dev/null +++ b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E @@ -0,0 +1,23 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAEXZzOmNhdGFsb2dzZXJ2aWNlAAAAC0dBVk8gREMgVEFQAAAAHABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAVABBAFAAIABzAGUAcgB2AGkAYwBlAAAAAAAAFBkAVABoAGUAIABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACcAcwAgAFQAQQBQACAAZQBuAGQAIABwAG8AaQBuAHQALgAgACAACgBUAGgAZQAgAFQAYQBiAGwAZQAgAEEAYwBjAGUAcwBzACAAUAByAG8AdABvAGMAbwBsACAAKABUAEEAUAApACAAbABlAHQAcwAgAHkAbwB1ACAAZQB4AGUAYwB1AHQAZQAgAHEAdQBlAHIAaQBlAHMAIABhAGcAYQBpAG4AcwB0ACAAbwB1AHIACgBkAGEAdABhAGIAYQBzAGUAIAB0AGEAYgBsAGUAcwAsACAAaQBuAHMAcABlAGMAdAAgAHYAYQByAGkAbwB1AHMAIABtAGUAdABhAGQAYQB0AGEALAAgAGEAbgBkACAAdQBwAGwAbwBhAGQAIAB5AG8AdQByACAAbwB3AG4ACgBkAGEAdABhAC4AIAAgAAoACgBJAG4AIABHAEEAVgBPACcAcwAgAGQAYQB0AGEAIABjAGUAbgB0AGUAcgAsACAAdwBlACAAaQBuACAAcABhAHIAdABpAGMAdQBsAGEAcgAgAGgAbwBsAGQAIABzAGUAdgBlAHIAYQBsACAAbABhAHIAZwBlAAoAYwBhAHQAYQBsAG8AZwBzACAAbABpAGsAZQAgAFAAUABNAFgATAAsACAAMgBNAEEAUwBTACAAUABTAEMALAAgAFUAUwBOAE8ALQBCADIALAAgAFUAQwBBAEMANAAsACAAVwBJAFMARQAsACAAUwBEAFMAUwAgAEQAUgAxADYALAAKAEgAUwBPAFkALAAgAGEAbgBkACAAcwBlAHYAZQByAGEAbAAgAEcAYQBpAGEAIABkAGEAdABhACAAcgBlAGwAZQBhAHMAZQBzACAAYQBuAGQAIABhAG4AYwBpAGwAbABhAHIAeQAgAHIAZQBzAG8AdQByAGMAZQBzACAAZgBvAHIACgB5AG8AdQAgAHQAbwAgAHUAcwBlACAAaQBuACAAYwByAG8AcwBzAG0AYQB0AGMAaABlAHMALAAgAHAAbwBzAHMAaQBiAGwAeQAgAHcAaQB0AGgAIAB1AHAAbABvAGEAZABlAGQAIAB0AGEAYgBsAGUAcwAuAAoACgBUAGEAYgBsAGUAcwAgAGUAeABwAG8AcwBlAGQAIAB0AGgAcgBvAHUAZwBoACAAdABoAGkAcwAgAGUAbgBkAHAAbwBpAG4AdAAgAGkAbgBjAGwAdQBkAGUAOgAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAYQBtAGEAbgBkAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgBuAGkAcwByAGUAZAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAxADAAIABzAGMAaABlAG0AYQAsACAAZAByADEAMAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABvACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHAAcABsAGEAdQBzAGUAIABzAGMAaABlAG0AYQAsACAAZwBmAGgALAAgAGkAZAAsACAAaQBkAGUAbgB0AGkAZgBpAGUAZAAsACAAbQBhAHMAdABlAHIALAAgAG4AaQBkACwAIAB1AG4AaQBkAGUAbgB0AGkAZgBpAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcgBpAGcAZgBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBoAGkAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQB1AGcAZQByACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAaABvAHQAXwBhAGwAbAAsACAAcwBzAGEAXwB0AGkAbQBlAF8AcwBlAHIAaQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABiAGcAZABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABiAG8AeQBkAGUAbgBkAGUAIABzAGMAaABlAG0AYQAsACAAYwBhAHQAIABmAHIAbwBtACAAdABoAGUAIABiAHIAbwB3AG4AZAB3AGEAcgBmAHMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABmAGwAdQB4AHAAbwBzAHYAMQAyADAAMAAsACAAZgBsAHUAeABwAG8AcwB2ADUAMAAwACwAIABmAGwAdQB4AHYAMQAyADAAMAAsACAAZgBsAHUAeAB2ADUAMAAwACwAIABvAGIAagBlAGMAdABzACwAIABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAGwAaQBmAGEAZAByADMAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHMAcgBjAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwAgAHMAYwBoAGUAbQBhACwAIABtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwBhAHIAYwBzACAAcwBjAGgAZQBtAGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBzAGEAXwBsAGkAbgBlAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAdQBwAGQAYQB0AGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwA4ADIAbQBvAHIAcABoAG8AegAgAHMAYwBoAGUAbQBhACwAIABnAGUAbwAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwB0AGwAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAYQBuAGkAcwBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHAAbABhAHQAZQBzACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AF8AcwBwAGUAYwB0AHIAYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHMAcABlAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAbQB1AGIAaQBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABlAG0AaQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGYAawA2AGoAbwBpAG4ALAAgAHAAYQByAHQAMQAsACAAcABhAHIAdAAzACAAZgByAG8AbQAgAHQAaABlACAAZgBrADYAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAbABhAHIAZQBfAHMAdQByAHYAZQB5ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAG8AcgBkAGUAcgBzAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQBzAGgAaABlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAG8AcgBuAGEAeAAgAHMAYwBoAGUAbQBhACwAIABkAHIAMgBfAHQAcwBfAHMAcwBhACwAIABkAHIAMgBlAHAAbwBjAGgAZgBsAHUAeAAsACAAZAByADIAbABpAGcAaAB0ACwAIABkAHIAMwBsAGkAdABlACwAIABlAGQAcgAzAGwAaQB0AGUAIABmAHIAbwBtACAAdABoAGUAIABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGgAeQBhAGMAbwBiACwAIABtAGEAZwBsAGkAbQBzADUALAAgAG0AYQBnAGwAaQBtAHMANgAsACAAbQBhAGcAbABpAG0AcwA3ACwAIABtAGEAaQBuACwAIABtAGkAcwBzAGkAbgBnAF8AMQAwAG0AYQBzACwAIAByAGUAagBlAGMAdABlAGQALAAgAHIAZQBzAG8AbAB2AGUAZABzAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGMAbgBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABnAGMAcABtAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAYQBwACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGQAaQBzAHQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcABoAG8AdABvAG0AZQB0AHIAeQAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABzAHAAZQBjAHQAcgBhACwAIABzAHMAYQBtAGUAdABhACwAIAB3AGkAdABoAHAAbwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAYQB1AHQAbwAgAHMAYwBoAGUAbQBhACwAIABsAGkAdABlAHcAaQB0AGgAZABpAHMAdAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGcAZQBuAGUAcgBhAHQAZQBkAF8AZABhAHQAYQAsACAAbQBhAGcAbABpAG0AXwA1ACwAIABtAGEAZwBsAGkAbQBfADYALAAgAG0AYQBnAGwAaQBtAF8ANwAsACAAbQBhAGkAbgAsACAAcABhAHIAcwBlAGMAXwBwAHIAbwBwAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAHMAcAB1AHIAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAcwBlAHIAdgBpAGMAZQBzACwAIAB0AGEAYgBsAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAbABvAHQAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBwAHMAMQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABkAGcAYQBpAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBpAGMAbwB1AG4AdABlAHIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBwAHAAYQByAGMAbwBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHAAcAB1AG4AaQBvAG4AIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAcwBvAHkAIABzAGMAaABlAG0AYQAsACAAbgB1AGMAYQBuAGQAIABmAHIAbwBtACAAdABoAGUAIABpAGMAZQBjAHUAYgBlACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABpAG4AZgBsAGkAZwBoAHQAIABzAGMAaABlAG0AYQAsACAAbwBiAHMAXwByAGEAZABpAG8ALAAgAG8AYgBzAGMAbwByAGUAIABmAHIAbwBtACAAdABoAGUAIABpAHYAbwBhACAAcwBjAGgAZQBtAGEALAAgAGUAdgBlAG4AdABzACwAIABwAGgAbwB0AHAAbwBpAG4AdABzACwAIAB0AGkAbQBlAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAawAyAGMAOQB2AHMAdAAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAYQBwAHQAZQB5AG4AIABzAGMAaABlAG0AYQAsACAAawBhAHQAawBhAHQAIABmAHIAbwBtACAAdABoAGUAIABrAGEAdABrAGEAdAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANQAgAHMAYwBoAGUAbQBhACwAIABzAHMAYQBfAGwAcgBzACwAIABzAHMAYQBfAG0AcgBzACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANgAgAHMAYwBoAGUAbQBhACwAIABkAGkAcwBrAF8AYgBhAHMAaQBjACwAIABoAF8AbABpAG4AawAsACAAaQBkAGUAbgB0ACwAIABtAGUAcwBfAGIAaQBuAGEAcgB5ACwAIABtAGUAcwBfAG0AYQBzAHMAXwBwAGwALAAgAG0AZQBzAF8AbQBhAHMAcwBfAHMAdAAsACAAbQBlAHMAXwByAGEAZABpAHUAcwBfAHMAdAAsACAAbQBlAHMAXwBzAGUAcABfAGEAbgBnACwAIABtAGUAcwBfAHQAZQBmAGYAXwBzAHQALAAgAG8AYgBqAGUAYwB0ACwAIABwAGwAYQBuAGUAdABfAGIAYQBzAGkAYwAsACAAcAByAG8AdgBpAGQAZQByACwAIABzAG8AdQByAGMAZQAsACAAcwB0AGEAcgBfAGIAYQBzAGkAYwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQBmAGUAXwB0AGQAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AYwBvAHUAbgB0AHMALAAgAG0AZQBhAHMAdQByAGUAbQBlAG4AdABzACwAIABzAHQAYQB0AGkAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZwBoAHQAbQBlAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AGYAcgBhAG0AZQBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAHYAZQByAHAAbwBvAGwAIABzAGMAaABlAG0AYQAsACAAcgBtAHQAYQBiAGwAZQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAbwB0AHMAcwBwAG8AbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbABzAHAAbQAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAsACAAdwBvAGwAZgBwAGEAbABpAHMAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwB3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABtAGEAZwBpAGMAIABzAGMAaABlAG0AYQAsACAAcgBlAGQAdQBjAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYQBpAGQAYQBuAGEAawAgAHMAYwBoAGUAbQBhACwAIABlAHgAdABzACAAZgByAG8AbQAgAHQAaABlACAAbQBjAGUAeAB0AGkAbgBjAHQAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABzAGwAaQB0AHMAcABlAGMAdAByAGEAIABmAHIAbwBtACAAdABoAGUAIABtAGwAcQBzAG8AIABzAGMAaABlAG0AYQAsACAAZQBwAG4AXwBjAG8AcgBlACwAIABtAHAAYwBvAHIAYgAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcwB0AGEAcgBzACAAZgByAG8AbQAgAHQAaABlACAAbQB3AHMAYwBlADEANABhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABvAGIAcwBjAG8AZABlACAAcwBjAGgAZQBtAGEALAAgAGIAaQBiAHIAZQBmAHMALAAgAG0AYQBwAHMALAAgAG0AYQBzAGUAcgBzACwAIABtAG8AbgBpAHQAbwByACAAZgByAG8AbQAgAHQAaABlACAAbwBoAG0AYQBzAGUAcgAgAHMAYwBoAGUAbQBhACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABvAG4AZQBiAGkAZwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHMAaABhAHAAZQBzACAAZgByAG8AbQAgAHQAaABlACAAbwBwAGUAbgBuAGcAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcABjAGMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAbABjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAyACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAdABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAG8AbABjAGEAdABzAG0AYwAgAHMAYwBoAGUAbQBhACwAIABjAHUAYgBlAHMALAAgAG0AYQBwAHMAIABmAHIAbwBtACAAdABoAGUAIABwAHAAYQBrAG0AMwAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHUAcwBuAG8AYwBvAHIAcgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcABtAHgAbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAcAAxADAALAAgAG0AYQBwADYALAAgAG0AYQBwADcALAAgAG0AYQBwADgALAAgAG0AYQBwADkALAAgAG0AYQBwAF8AdQBuAGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcAByAGQAdQBzAHQAIABzAGMAaABlAG0AYQAsACAAZAByADIALAAgAGQAcgAzACwAIABkAHIANAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAYQB2AGUAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHAAaABvAHQAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIAByAG8AcwBhAHQAIABzAGMAaABlAG0AYQAsACAAYQBsAHQAXwBpAGQAZQBuAHQAaQBmAGkAZQByACwAIABhAHUAdABoAG8AcgBpAHQAaQBlAHMALAAgAGMAYQBwAGEAYgBpAGwAaQB0AHkALAAgAGcAXwBuAHUAbQBfAHMAdABhAHQALAAgAGkAbgB0AGUAcgBmAGEAYwBlACwAIABpAG4AdABmAF8AcABhAHIAYQBtACwAIAByAGUAZwBpAHMAdAByAGkAZQBzACwAIAByAGUAbABhAHQAaQBvAG4AcwBoAGkAcAAsACAAcgBlAHMAXwBkAGEAdABlACwAIAByAGUAcwBfAGQAZQB0AGEAaQBsACwAIAByAGUAcwBfAHIAbwBsAGUALAAgAHIAZQBzAF8AcwBjAGgAZQBtAGEALAAgAHIAZQBzAF8AcwB1AGIAagBlAGMAdAAsACAAcgBlAHMAXwB0AGEAYgBsAGUALAAgAHIAZQBzAG8AdQByAGMAZQAsACAAcwB0AGMAXwBzAHAAYQB0AGkAYQBsACwAIABzAHQAYwBfAHMAcABlAGMAdAByAGEAbAAsACAAcwB0AGMAXwB0AGUAbQBwAG8AcgBhAGwALAAgAHMAdQBiAGoAZQBjAHQAXwB1AGEAdAAsACAAdABhAGIAbABlAF8AYwBvAGwAdQBtAG4ALAAgAHQAYQBwAF8AdABhAGIAbABlACwAIAB2AGEAbABpAGQAYQB0AGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcgByACAAcwBjAGgAZQBtAGEALAAgAG8AYgBqAGUAYwB0AHMALAAgAHAAaABvAHQAcABhAHIAIABmAHIAbwBtACAAdABoAGUAIABzAGEAcwBtAGkAcgBhAGwAYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIAMQA2ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAGQAcwBzAGQAcgA3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAG0AYQBrAGMAZQBkACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAZQBjAGkAZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAbQA0ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAHUAcABlAHIAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAZwByAG8AdQBwAHMALAAgAGsAZQB5AF8AYwBvAGwAdQBtAG4AcwAsACAAawBlAHkAcwAsACAAcwBjAGgAZQBtAGEAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcABfAHMAYwBoAGUAbQBhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcAB0AGUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGUAbgBwAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAZwBhAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAaABlAG8AcwBzAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAbABpAG4AZQBfAHQAYQBwACAAZgByAG8AbQAgAHQAaABlACAAdABvAHMAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdAB3AG8AbQBhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABpAGMAcgBzAGMAbwByAHIALAAgAG0AYQBpAG4ALAAgAHAAcABtAHgAbABjAHIAbwBzAHMAIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AHIAYQB0ADEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAcABsAGEAdABlAGMAbwByAHIAcwAsACAAcABsAGEAdABlAHMALAAgAHAAcABtAHgAYwByAG8AcwBzACwAIABzAHAAdQByAGkAbwB1AHMALAAgAHQAdwBvAG0AYQBzAHMAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBzAG4AbwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB2AGUAcgBvAG4AcQBzAG8AcwAgAHMAYwBoAGUAbQBhACwAIABzAHQAcgBpAHAAZQA4ADIAIABmAHIAbwBtACAAdABoAGUAIAB2AGwAYQBzAHQAcgBpAHAAZQA4ADIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAZABzAGQAcwBzADEAMAAgAHMAYwBoAGUAbQBhACwAIABhAHIAYwBoAGkAdgBlAHMALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGYAcABkAGIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAaQBzAGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHgAcABwAGEAcgBhAG0AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAegBjAG8AcwBtAG8AcwAgAHMAYwBoAGUAbQBhAC4AAAA3aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDA5LTEyLTAxVDEwOjAwOjAwAAAAEzIwMjQtMDItMDZUMTA6MTk6MzMAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAFYaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vZXhhbXBsZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi90YWJsZU1ldGFkYXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXAAAADYaXZvOi8vaXZvYS5uZXQvc3RkL2RhbGkjZXhhbXBsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSN0YWJsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNjYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNhdmFpbGFiaWxpdHk6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwAAAAeXZyOndlYmJyb3dzZXI6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHAAAABIOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkAAAAPDo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Og==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta similarity index 58% rename from pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta rename to pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta index f8fc0da63e8e66c46c82584ebd3b6eb0f9727277..f4dc32860a4ba98138dccb0ade9e7a3d307219e8 100644 GIT binary patch delta 124 zcmbOv{zQzWfn{psM3(;|MrI0bsYwb(21X_d29{QardB4#o5dOB7$tNID#QHs4fV|Q zQc}yz4Ykvgl1z-!QWGbKGwo(JHZz?p&8W25ocSQ5%>J-DsijF79<@_4QoJCX9+ss1 Zl*%a)p_@fmLzy>Mb1*Y)p1{S#2mtq1CW-(6 delta 167 zcmaDNHc6bNfn{p@M3(;|hDHi*sYwb(21X_dhDKH<##Y8=o5dOB7?sQmD#QHs4fV|Q zQc}xIjI`5@l9SU?O$_x?K#C2F42>rHGVNwIF)-ZB&HR{Arb6gcYH3o2N9~l16fX#; xhb1XLrE*F{OqUMI$=}Ac@Mro;u ndMO}z10y4|&0S1JOae!v?xdC`Ww_K%$w=@5ayFk~5n%)XSP2^n delta 86 zcmaFB{eXMIKgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&xgD+9~T;*4>OqQ<7$=_W=NDP{&{ ndMO}z10w^A&0S1JOahtbkEE6+Ww_K%$w=@5ayFk~5n%)XJeC?< diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta index eceeef11a0baa73a20b3700f01b892e10e59d28e..fade371ce5055631c9839343430de5932fcd1b8b 100644 GIT binary patch delta 86 zcmbQvJ)L{PKS|&GJRJoiGX=NQBn2Y_BNGJ!ODkg|D^ugm;*8RaqUMI$=}Ac@Mro;u ndMO}z10y4|&F)M_Oae!v?xdC`WjNGM$%yd+ayECe@G$}a5%3wI delta 86 zcmbQvJ)L{PKgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&xgD+9~T;*8RaqQ<7$=_W=NDP{&{ ndMO}z10w^A&F)M_OahtbkEE6+WjNGM$%yd+ayECe@G$}a_HG#S diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO similarity index 94% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 rename to pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO index dcf9269f..03198a08 100644 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0 +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO @@ -1,6 +1,6 @@ -Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. +Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The IVOA-defined obscore table, containing generic metadata for +datasets within this datacenter. The calib_level flag takes the following values: === =========================================================== diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta new file mode 100644 index 0000000000000000000000000000000000000000..d83724cc9471365cb6f05e17f972649c210175c9 GIT binary patch literal 1910 zcmaJ?-*4MC5YCpg$(pWd)~(pE74RNhq;)JSa+=fy@(|cr)27W2Cq=gb13^i2q(%}| zl8WO31=g2g0r)oVf7&0hKV~0o*=~n*elU5*yW{Em?vB6C{dqP&GyJ_ZD|%5XstQR0 z9x}7{m!6Lp4VjQe-xBO~!K9LoRH6t}A(+*+sbo(w$ub$M_?&g(K$$ zUNUjc1UARz=1zyUcaIyM({j9u>c>*C@Fnvbp6fIn*ZRzbR3V|c&TzT&oM)>QZ=>=9 z^DCa~tykREqo(_)xmkJq{KVQ{4|t|nrs`^t!|!^#6isa->>($Nb7)fSgONXv|KNsY4}-e zyW-{;3}>QRE=iK@q0v(+rgY7doTH2e$k9?%I=zC4zSUtpS|n=ZbvQCB`wQifF(m_v z%KROr)(gDW#shPSR>gMBZ4oNT#A07xk3e>rqzALl(a30567rPB85G}^iZT)@GPGCR zi)~TkhTG+FCOug_2%hyffC+Hy-mYGX)4?3D8y#JnVU(b<@_s!F-pZ{isAML(1QCJFk z&gbF4{Mh?sW~RGy^kV1uWGm!H1rvk2&$jm;Z*6yup52AM`_qCK-gd1gcv_3k zId!-%15CEs%iW#sP7O1KBHs{Gk=Qv=ZFZ{OW}Kp3u-3NsJ8*xv2DPn8U@al$JkAtW zSUhQWkFiv}c1;pNM{CG}s@JmnAQnM_NdGcjYp&bVwKezl0ZwuYZ(&FDq7x${vo zgtaW9@TGkg7VvW9cnO&K#YlaFST4{3_5tCU*)MD>rBnqGX8XQgBH&y?AKXE|X{x^wWx-v$bOM*B_g4Mt?RPb9%-^MN}yB4#h=YkCG!QP8o-C@5^yj zVF-t@uvj9Wc`|H@fo(awZ-UVj+bbksLg9G9R_=wJ0>jCvmq>sYl1v^*b6NO>^A8>~ B#(e+) literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKuPEG5cf0.meta deleted file mode 100644 index a4d3f31ff4e47602c4018418a9292af70dc5f33a..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1888 zcmaJ?OK;mo5O(WlZ8x@Sv}n-=P!9_1(4r{HZ@>q`a^ohh{BGJqu~?ELkuk|-c9)hF zz(8{;YG7~O{-Yjx>tE`uL`n7`;e|WHnc3y{eKY&}#NSubW4-52uc$d8smulOSpfRg zziK)J8UPnsEpvFAgOI`&lIOn6IT-H&74Ty!AQh2}ZlDqQQvan_-|IWArihS?gI04s zi(~L*#8S+eJKW+wK6s6*WVKfeV8Ic7oi*h~vU3hm0bS zMTJq?R01+&0siOd$;G8s<2jGDS_!4hcB|FEx8Kpw&eNz8LWH$E;B7mAs-#&}bW>l4 zpN5k?3d5OjZq@KJnVa!;&A3^UkO>^d@Svp6Jk=vpdR6bHSamz0nAoF*AVopteyhC{ob z^aexJasyg4k7YmWv>#S9AnGRtDSV33{S&p=^4*=y4SkQjjLVv{L#QCbh^CqkQ4Pf* zT@3piJ01I(1T3LZijHp!M^TC7DfVB~ij3-Uhp&pysd)V5UM-Hk6vbYRsqaQk0g^;1 zP7oU7ZgGr%cCWs8{5_*ck|_l~&K{C+CK=8ZM03)Bg75K;5QeWs;>Flx5ELgDdKG;% zj#=k{uc;KrJ_g=NKyJMB>2bN>kEXJ)GmWpsf zaYRK5%=9Df$EL)Cj9xS*_A7E|4!MRn`(|= z&k!7GQV{GqG~&p!(Z+l=cWU0}AW-bs87peSu&&kD9~x&`eKwkCYD|ZDm`nX0WkTNe z4@YE_07GYUAP*e3LBtJ|=$j@zb$3ng;7!JXCb*m=K5&yVV -ADQL query translated to local SQL (for debugging)ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
+ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.
\ No newline at end of file +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with. \ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta new file mode 100644 index 0000000000000000000000000000000000000000..dbc1df27d052f341e6b5d1e812cdfbaeb440ad43 GIT binary patch literal 3241 zcmds4O>YxN7>-IvQj!u<)Jj!Bat}d)#cO->g^@TI$AN%j2it*is7B-6v3JROcbS>B z<4Q>7QZ>@vy1n$!pVD)GM1M@5*ci+eF z;%I>g>2nrG%ck$T%#@DrfoHkNA(B}W+7|S#Nlrb{V?571=ytq*9IbUGxY`uAXxgE7 z!mRjbh!>0x8ONcW9d7T@>eF_?(961!lOsn+X1!wFf>G2r^`hdLx2S|c^LxqT_Mz|H z&lx+peb&txMPn;hEI%x5Kio2MPYyeZe#P`X$vl~t;{bds)eP(;;5Re~T*sv9VujQE z(3iC9GVOHWf;SZ1XfbnI9DOx$9~t=Oi9W^OB(2o1&F&j`=!pBL+5|OtNXlPkTfWW zv1i8iXZF=3Z1$49d{@QfS_lW{X&={*qie?ssH8wX7{6>5O8Sm&vEgn>>vy|bMvu|l z(HMHY!lqs-Ap#q9#|uyIDnG7L(`11>7v0rLikZcBt^cDF+|OC8=OQ}yb6u`D7gA0f zQU=`SUg4g4a}BZa(yRi2$jpEf#)3R`k&ue;`Xq=h^ZL>TViLxBhL|tyl#~3pINslV z81K<&l<)a`kcWGdv`z9-#eE3{nJ75Y7MF4F)2)nEd2#(*E5as&USo;vc<7fEE6iol%f%>*p9_A zBMp#!fucs~63ZV@#{=Tq43SA9p@&j)dX7qPX!tsN?THWHoJBWgZ!%%e=b~FPq+pUb z9-0Mpq0M!1v$N>S58nqAQBtCqi8ez5?n@sn1m3)=oPy_-kq|1hH%Qk-Juxe@T*P;Q zqps_Z&fyx-Jn{Td{Or${f3vV_KYbV5Rt7}#UEdnV-~YZaH`l7YIIgujk1YR1$oTk9 zz0!E{sIvE>eh2v0>qqTcy;kk47c0)tcdT`zs-X!I)f&`U*gluUqk{xW-Z;`tfGh!t z%ZALI@L5cl+zC|kNKt5iNFzp&P6}aiM$tcsU~i`&OSFc8YGbJZPT!Uyd7rkXnK^#Q zAxtGGm5M;5h#_^u%)&lY6TgQh)2BQUH=;w&Am>vr@0M zt2G=|WeOxfYVNwRn|#YkmpW}$(r+-IdTqa>HIF;BmiDZ9(9l2y5wz>LjvQZ12bVJ5qb9qUjJjwy7DgC)7vmSx zs*<&sq>g(roscFG=uv24pF)Tc#S_X`Piw6jI8ZvN8gi;SowmNYmlTY#f9~?eK5CpE zs#(8o?5}SXQHgn#^}AZ7v8R<1E>)eLZ(;{SjhpsN@U+N54}c!8b`o$DZy6S9i4KTM)l{2}PUWD{2I8<;#qW-)@#;aVT33Cbw7I3=Qc3+5 zbvzO=08AfK0~!DmG#!OL6 zbth%ylUDQiNPGMmM_lXw-H+Ae!?GaMTD^ok4X{bG_=i|T*NK{6*c#LV?t5_~RO?5Q z4%m$w(X#5#1bd7op)vNd{}l0A*bVi60DjkLc>n+a literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS.meta deleted file mode 100644 index 127d74d51834700125bbb9322dfa1173d3fd609d..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3250 zcmd^CUvJY^6t6~UJK9k?v`N!I>K=*;CQjnCr9t8$q$!kzq$DYfhw19ZzKKm8+uVDd zG?S3V%d|>bjOFr-7&1hLj zDnmg`-(vB%e@2ToqZZ>Lj&5@HHe^ByT}U39GUQBQt5mQ9PcTn7(iyTn$CU9e@!j|F zyEs}PLi(J=(X#2gE;FU$d*E4aa)@Nsgti5}Ym!q>^cc@E54s(%A4hAQ39dH9Et+=d z9WyKb3E~CgL&kAvXNTK+wEDE2H}tY@tjm!jB(q+zZr&*9CB2|{<}E5=(EMKVxZSbC z`|E|>^?lY|HwwnqdeL~ez4NfRwf^LJN71jCz9*R{b8;MjZ>5@nodo=f27&9CR9!58 zk{kMxc3q~O3|#Prq8lw{PK%>2Chj8x-#pf*_?x7a`nB180}mZ?|71LI;AXT$ri7~# z0r~*3apA|+L(T#UM`jXcYzqS>ZQsH@51Z{y99;>y8%MWnDT9akJZF8q4`X$o_w$kl zc`^3P*#5-6nuN_>vX}3wm|P3t;2iDa`f+saNCA};co2+VHuFV&N4MCpw5|2Gj9qJ| z08lxxV8Ek?V_4wjOM0=0SZvlEFFd)cJi1CvlLhijoL4I;W)|hO{tr%Yf8Am|7je43 z-sOsOA?3s&Wx&1e@{b)=D>tSQoTApU(1~h7^o;UZ5En_{ zBe}*fQUy*=ncjdTy1B=CG<0Rkb(oT6RfnYUm=q>OzW$5^?3qS+XFEPc0pnOKlnE7N zO3{c`Y{z1mkp{>ATprG9a4o`qnu9?ze@xxmNAPQLWv1 zWce>b#>aQ+mBy1tmAx1BJHWSIKWf+NwQ6UhP;rL7V{I5!4egMqCZW#4_PHb;9VAfl z#*uCUWC=)IHe~LE&tk&lPN3RIib5kq8Zm-&QV5eXicU%ddpiYLqBRUuLrV>C`nD9w z`?N{T%<)4GVJbnXR0JYL45=Gt7WSc<_&v0nKIMtH5goEF^^!C0scE<=`Z-5yCbZw* zFm|iWO1;*u)^JpnDUblExf{lVaXJmYwQpc0Msar3law_3JDCB;cJC|3eBz&Ag^bPVsI$lcc2XYeS)J4Ht z7$@i+j3dJPt>$w)ILACpa}rRa(m85X>RP?F-_e>!omxwK);wrvpn_1^bzDb|FQ$W& z8Shb(T}<{5doEC&6tQY~7mF0qBmzwfJ?&!%F|&9=`RZw{RRafVDcK=NsCtR!I>$^^ z5Nc1AjIoa|&QwPO$5BX>=f2++Cf2MCqm;1biu#7J4JNJ9*qgQ`ZKJfOBn<@wVPm1L z-=8{N)oU5rwS)yW6ch4lv(c#>G}=HsZ&vZUqYAou(5lu|(HBcw3N9AaZ$ZZc1)tQs z>0?A-amX-d1ef)lVyUoQ-Yt~M>a)vo#RuBsTIW@**3d+dIs|=&a+w%2MKRTil#x$b z&7(u@@oOCa7tQy4ma4&rT|ub*dI(nWigIEo$ZU!Tx^GSDC75- z!Q^df5RuM+`9L-%vlkP^ayY^&fLkQV>M&M|iJB#h4sg6mOvV+Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAsaXZvOi8vb3JnLmdhdm8uZGMvX19zeXN0ZW1fXy9vYnNjb3JlL29ic2NvcmUAAAAcaXZvOi8vb3JnLmdhdm8uZGMvcm9zYXQvcS9pbQAAACxpdm86Ly9vcmcuZ2F2by5kYy9fX3N5c3RlbV9fL29ic2NvcmUvb2JzY29yZQ==
\ No newline at end of file + ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAsaXZvOi8vb3JnLmdhdm8uZGMvX19zeXN0ZW1fXy9vYnNjb3JlL29ic2NvcmUAAAAcaXZvOi8vb3JnLmdhdm8uZGMvcm9zYXQvcS9pbQAAACxpdm86Ly9vcmcuZ2F2by5kYy9fX3N5c3RlbV9fL29ic2NvcmUvb2JzY29yZQ==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta index fc3948d7e5b294b81f28b947c8495d8708ba1f76..42325ca05bdfde348471a4af0967dcc6d1b5e0fc 100644 GIT binary patch delta 375 zcmdlexlwY$KS|&GJRJoiGX=NQBn2Y_BNGJ!ODkg|D^v5$;*8piqUMI$=}Ac@Mro;u zdMO}z10y4|$>B`@6->>{EG^6vEmPABOcM>#(##AKQ<5z#l2Q$mj7*Y^Qa6_|&u4Tz z8FeSMG%3TQc1lKy7lhNpl9ZoPImM}(je$W|myj`&`Peij*RhHdv=6NCE~_9xg`4@< dych|p0vor0U4|%yn^`#8nF*@gyqcSh5dbF;Y@h%D delta 375 zcmdlexlwY$Kgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&xgD?`)G;*8piqQ<7$=_W=NDP{&{ zdMO}z10w^A$>B`@6^txWjSbB#4U!Ek%u|z$4NMGEERs@^O;b|R42{w(%{G@Y&u4VZ zKYt{(G%3TQc1lKy7lhNpl9ZoPImM}(je$W|myj`&`Peij*RhHdv=6NCE~_9xg`4@< dych|p0vor0U4|%yn^`#8nF*@gyqcSh5dfbkX(a#v diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ similarity index 51% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ index d83b5eaa..7bbb947d 100644 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ @@ -1,11 +1,11 @@ -ADQL query translated to local SQL (for debugging)ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAEzIwMTUtMDctMDlUMDg6MDA6MDAAAAATMjAyMy0wNC0yMFQxMjowNjo0NQAAAAAAAAAHY2F0YWxvZwAAAAdiaWJjb2RlAAAAEwAyADAAMAAwAEkAQQBVAEMALgA3ADQAMwAyAFIALgAuAC4AMQBWf8AAAAAAAAV4LXJheQAAADRodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3Jvc2F0L3EvaW0vc2lhcC54bWw/AAAAFml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA
\ No newline at end of file +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAEzIwMTUtMDctMDlUMDg6MDA6MDAAAAATMjAyMy0wNC0yMFQxMjowNjo0NQAAAAAAAAAHY2F0YWxvZwAAAAdiaWJjb2RlAAAAEwAyADAAMAAwAEkAQQBVAEMALgA3ADQAMwAyAFIALgAuAC4AMQBWf8AAAAAAAAV4LXJheQAAADRodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3Jvc2F0L3EvaW0vc2lhcC54bWw/AAAAFml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAA= \ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta new file mode 100644 index 0000000000000000000000000000000000000000..db8885a89fbe9062e84410e30372ec96280595c7 GIT binary patch literal 3107 zcmds3U2oG?7_LTXJK9k?wrSHq$}WmpOq`E?K#;fyX$pljDM5C z%_O98Gp&;E=KY)ffc=R5m_5gKlEOvDdb!Ao&-?oQI`8){^M8E1GMD_`#T(JGkW_|( zn7+m0=YK_uHlr5fB93ly_BLcf3SCGZnlj`}VQW;d15YqdIMNxiJ;#*s@A2mQ_+1<= z5Fvfe;%M3QU6+~C@jdV?w>U&HYeL(G-ZjaoCwh$MnFrmD*N>yM?gUq#;ucLi^iG%+ z{|fPf@gd_lbh5+kJz9I(DU|h!Ue3vpBP6q4F{4l}>RWnI@yuIP!l3!R>?-;d)AuCvWL}N~@U7G`u$zG2(I9Xgld6jqPV+-w zQp081>A(eVD2!+^b6OmIJ#ily_~wZ|#or|D)UPe$4Lo$j{nPQpfg8~hnG&u}1n2|A z#)ThOk2nh`9GOX&u`LXkw0#TrJZg2iadai*ZXDgRr3@Yx3Y_)zK8)3U-Y-ZR6vWsw zWBW7vY7#bk$zI-6F}W7P!Fk%p_2cN;u>z_okPpT$TZNLot6OY%zohjIW4qjAGigO|5#35zC zZSEHCsxQ|N8!yc&0Eo;CIAJWvQx^%T2(M3q=rXS_Z6GFLY-EV}($3DVBE2}?KYSSP z(P)(K`FxOvdy}+H@>0cp2?gYzII2Q!Oyf31tz`idwS?#y<+IQ&lE6nwjbWq;m!2}c z0ZDXokM(Hi%9QIUCCh3Jsp2syOo}Z14Qbai%az@o_zY!>W2smnRFEk}Gg`47i)BWZ zLG}fT8l_7te?T1%i0?B*CW(X|O3mpxD#4-Qo9weEKKybP-I#sJggu{&Zq1N_N#b~D z7Sx3{*Tv1wqAx%E9#BL{iDD+&3<yOUin$bM*{89Yu&zFC*(6FDri)||dqItu&#_^9|EzHfe>o1P$o$e#ce-Sc1zSF2S zpFFDWy=dG4zWw@9r{1X7y6eTNGxQy6yMU%ZOXAT%0wrG@=_WvyfW&1( z=1%x5CQR-Gs(GX+v_GT~BSpG2^?Q;;QE!$7sM)BvY%OObp}Thq)OKjaXm z5|m0sAX3DTx?yHvAF7GpLzC%Ko`@UKAv36#oN-T0!%fk}IT|vd{r-CSL9JD7)H}60 zj;b;R5+F5qy?j4;DoU3+ZB^4J7;7(Enqa{clhSF`jy4mK+~HqUVmx^kY$d7tFQxOG zj89YQc(ONj>!nmqCHx14+)s1o@(PuNPg97#K|V^yOR4=xjzB#3+pR;qILFLOGZ0X- z+C6Sp8(O2j-_=^j-FjPl);efvpn?c$IIbhd7t_I|jQ6O?E+(Tc+Kq(~hTg^a#k4}2 zM4)=31oXaf@_W=feL=CCbFYn{Qnd)f7I0}g}+ZPT^T#d4+ zK!&DOn|q3{q^)o5X|-0fTRmuYfH-W`@V~37t9Hh-23g7jJ_ddg*D%oN2`Ur|R-KVx zLz9AFvjE^ah7K6~(ejacx0%2|$MoNb=G9~a+4=1(jy|6)Xwh73hju9A_ZWZVZE6sa z&VczqHYZ~b&D?T0f+&DnB+1kstDQi#aYhF?UL_{uie*WS)>E~nBr9LEN=&Tt7&zHB KAD@LrsQ&{8%{`a^ literal 0 HcmV?d00001 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm similarity index 53% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm index 42d2644e..e14ba64d 100644 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm @@ -1,27 +1,28 @@ -ADQL query translated to local SQL (for debugging)ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAABEaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAAgaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAAAAAAA
\ No newline at end of file +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAALGl2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vb2JzY29yZS9vYnNjb3JlAAAAEnZzOmNhdGFsb2dyZXNvdXJjZQAAAA9HQVZPIERDIE9ic2NvcmUAAAAeAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAIABPAGIAcwBjAG8AcgBlACAAVABhAGIAbABlAAAAAAAAAGAAVABoAGUAIABJAFYATwBBAC0AZABlAGYAaQBuAGUAZAAgAG8AYgBzAGMAbwByAGUAIAB0AGEAYgBsAGUALAAgAGMAbwBuAHQAYQBpAG4AaQBuAGcAIABnAGUAbgBlAHIAaQBjACAAbQBlAHQAYQBkAGEAdABhACAAZgBvAHIACgBkAGEAdABhAHMAZQB0AHMAIAB3AGkAdABoAGkAbgAgAHQAaABpAHMAIABkAGEAdABhAGMAZQBuAHQAZQByAC4AAAA2aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YWJsZWluZm8vaXZvYS5PYnNDb3JlAAAAEABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByAAAAEzIwMTEtMDMtMjVUMTA6MjM6MDAAAAATMjAyNC0wMi0wNlQxMDoxOTozMwAAAAAAAAAAAAAAAAAAAAB/wAAAAAAAAAAAACNodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcAAAABppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eAAAAAx2czpwYXJhbWh0dHAAAAADc3RkAAAAAA== \ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta similarity index 52% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEa8WmYWeZ.meta rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta index 494ee1fbd666934476074d531d40fafdb7a53067..b9bc24fe8a0f39627c41fecd494892ddf75d455d 100644 GIT binary patch delta 231 zcmcaD(IUyxz%sRRBFisH-~2os1tT*Bx6~vBBLgE71p`YfLsKgg!_DH1a*PtX1(jj` z`i6RDdMT-8=7!qoNl7L~X{m{m!ng2&U}zjW^dS?)Y7C3kJ>32DP9mx z4@**hO68P@(#;~Qq0E!3Io5I%r54ARBqrrd?&FZ3tikEb4dSH6mzGo(q)sm5RCCNv zDo)NXN>w#72FvIg>Zux;sv4PVJNmh3gLMN{YO5N%XafbyidBsrlM_o4bMn)Ha`~l2 R$*G&ya?WDh9LdeZ2mm28O9}u0 delta 213 zcmZpXye+}fz%n&pBFitykc?6t1p^BOx6~vBBLgE71w$h%Q!^_=ga diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl similarity index 54% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl index fdec5b73..671dd918 100644 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaELi0sXtHS +++ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl @@ -1,28 +1,27 @@ -ADQL query translated to local SQL (for debugging)ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +ivoid, res_type, short_name, res_title, content_level, res_description, reference_url, creator_seq, created, updated, rights, content_type, source_format, source_value, region_of_regard, waveband">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource
The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. +http://ivoa.net/rdf/voresource/content_level. The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. +http://ivoa.net/rdf/voresource/content_type. The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAALGl2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vb2JzY29yZS9vYnNjb3JlAAAAEnZzOmNhdGFsb2dyZXNvdXJjZQAAAA9HQVZPIERDIE9ic2NvcmUAAAAeAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAIABPAGIAcwBjAG8AcgBlACAAVABhAGIAbABlAAAAAAAAAGAAVABoAGUAIABJAFYATwBBAC0AZABlAGYAaQBuAGUAZAAgAG8AYgBzAGMAbwByAGUAIAB0AGEAYgBsAGUALAAgAGMAbwBuAHQAYQBpAG4AaQBuAGcAIABnAGUAbgBlAHIAaQBjACAAbQBlAHQAYQBkAGEAdABhACAAZgBvAHIACgBkAGEAdABhAHMAZQB0AHMAIAB3AGkAdABoAGkAbgAgAHQAaABpAHMAIABkAGEAdABhAGMAZQBuAHQAZQByAC4AAAA2aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YWJsZWluZm8vaXZvYS5PYnNDb3JlAAAAEABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByAAAAEzIwMTEtMDMtMjVUMTA6MjM6MDAAAAATMjAyNC0wMi0wNlQxMDoxOTozMwAAAAAAAAAAAAAAAAAAAAB/wAAAAAAAAAAAACNodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcAAAABppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eAAAAAx2czpwYXJhbWh0dHAAAAADc3RkAAAAAAAAAAA=
\ No newline at end of file +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAABEaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAAgaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAA= \ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta similarity index 54% rename from pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE0N52AqRD.meta rename to pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta index 36966ba66d0830941277fc855aa8d1400186523d..262c664b5bbc461ae875face2ad7876c3de816d5 100644 GIT binary patch delta 158 zcmca8u~vemfn}=FM3!HYzWI4N3PxrMZmCHMMg~SE3I>)|hNe~~hMUD1 z^$qpR^iopG%nh~Elafq~(oz#AhcoSAGBcYj&8W25ocSQ5%-*m&sijF79<@_4QoJCX z9+ss1l*%a)a+^h1LzyR6bNpe=$;?jGo?OeR%5Pj)np#w;Yow=YWU6XpzIhqvbjHp8 H+)RuB)g>_~ delta 191 zcmZ20aZ!S$fn}=OM3!HYAsMAQ3I-MmZmCHMMg~SE3Wi2jre;=##+$_% z^$qpR^iopGj7_!EO^hs3%nX2BkYWQP1B=PNOnaCtjW%;LKW3E4J%1#%G%3TQc1lKy z7lhNpl9ZoPIVHkkGZ$+pv!Ic)c4AIRd}c~&UP)$JW@^#oIF7$;o_^Y@Mi!G3I8|B9 WRgEk+PvM--D5Q#^cC$7&6C(g$+dAq1 diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEprobT%Sr.meta deleted file mode 100644 index 6f68b78fd9e65791561c0af7fcb2097b020a62ed..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3287 zcmds4OK;mo5H=dec4Ie=8?->t1aJ=uoG_v!`W+w#MV1n$vgAl|(j1D#id>0|DU#V; z%2t5@&84UT-pc-+o_gq^K>t#|B`L{H0XOxrf*|e;=e6_JkF&r2xiph}-o1r=I9Bo@X9(J6=DIRyt!`b%L8W?a(`B zR{Rsh3&w|x1Mp0kai;8E~q7nwp?j?`A9Xouu zTHIN!vF@r-G&WXC#-q)xN2QI`rw1KHzhwHJWS-2+Q2@TBN(Ock@GBYwu47VlvBGJ7 z=u6slnRYsG!5fNhG@m&wj=mVXj|_bCSfAi;lUC~2X7>#|bjbbF(b$1&(E^zeE{_H1 z1H{IKAD0g~3n(0!Ntm+D4Vbij3->&1wmWfjE#z(--La(%9u*3l_4PiC)qUPCNE#Hx z$TMU66Z?7+HhaNdysu(%BZPzVw2$k@(TyVolv7|k7`<#3O8S;=vEllr*55F8tgRwI z<;0=^j~3!wVWonu%kmusOTuw35D6jN?aDs=c7VEi))5Fy+ zSDbSxCk`nC?)9MXK)tzvD0yjq0YHqVz%gS%p1Md)MR;=@PM3LoX#+71Xgx#BmbQ&8 zMS6MUzquIslarHt&*y_Y9GxU^lA$UC7Ent5v7>6`)+B-x)JhgQQAvoNQ$7viJPCXx z*9b7$vzo7a_7@Vs^+go@WK(sfZ; z%*rem@qOT^>-s0>aE)k|c>YQJ-23Zy7Iy7t?_%4^fM~YsTch~9-{xj!TGbav)pqBx z<-Z6SAKj~$8&4mX_g>WR0pEK4xLvJRE1g`i>PF@khb2$M64PD%uOI{{guH4IckOAT=PwiL1I({NMtbB@+bXuqE` zb}G$sz1pr+aa5HlkN~N&VgNbZ|1` zJ!-Pc$^K!_C8|{sTTD{NyRs3kfeE>%-$Hag|~MjMEOW(B`ns_HBItx8>W zhSK_mf=ea!Th#GL!~igT%n@uC8RneeU45&xUfkT>DX#CT&koC%wzVhK&Z}y*p@|@M z8k!O1GBIX?Vya&$BcHaKM~B*z*Er%@|NjnsF_qPH#6ls|625@U4X}5!`1@EyH;I~Y z*euk#?t5_~R4Yo7AlRfE(W2_%1Y4yP1UnD_*Xinj!5=Lis%MJ{tRC1?)}mQ8gF$wF zql}|Zr%Pot6WgI3%J@A7HF=vFM5HrdK9G&^fX3Ld9FDLG;O0rPUyRiDq6QA5101gt glX1nepq7ABwNNE%YP3vLieofp|3Koiup8=s1790>cmMzZ diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill index f3a44423..7824d11d 100644 --- a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill +++ b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill @@ -4,4 +4,4 @@ JOIN tap_upload.ids AS leftids ON (ivoid=leftids.id) JOIN tap_upload.ids AS rightids ON (related_id=rightids.id) WHERE relationship_type='isservedby' - ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFw
\ No newline at end of file + ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFw
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta index 78c5bdaa9da25f3f12f519114d66ad3cd5eef292..cb5f9024a69edc655b599987f86d7d15dbbb2ffa 100644 GIT binary patch delta 375 zcmca9aZ_T#KS|&GJRJoiGX=NQBn2Y_BNGJ!ODkg|D^rWj;*8piqUMI$=}Ac@Mro;u zdMO}z10y4|$>B`@6)a6mj8c+K3{%XK5)D$4ER!rOOiYc8ERxO4ERxeKEH;-h&u4Tz z6?G@IG%3TQc1lKy7lhNpl9ZoPImJntje$W|myj`&`Peij*RhHdv=6NCE~_9xg`4@< dych|p0vor0U4|%yn^`#YnF*@g9L&we2mnL9XgB}> delta 375 zcmca9aZ_T#Kgp1cQXK^Y3kA2-Bn2Y_BNGKfBP&yLD^s)0;*8piqQ<7$=_W=NDP{&{ zdMO}z10w^A$>B`@6--hsOj42!OpOvvO)OF^&C-kw%*_&$O-+D^D_j5e1s&u4VJ za{fqaX;Owq?UalZF9@fHB`H6pa*C5O8v}!`E+Jzk^Ra16u45G^XdhVNT~ -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAAAAAAFWl2bzovL29yZy5nYXZvLmRjL3RhcAAAABF2czpjYXRhbG9nc2VydmljZQAAAAtHQVZPIERDIFRBUAAAABwARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAgAFQAQQBQACAAcwBlAHIAdgBpAGMAZQAAAAAAABQZAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABUAEEAUAAgAGUAbgBkACAAcABvAGkAbgB0AC4AIAAgAAoAVABoAGUAIABUAGEAYgBsAGUAIABBAGMAYwBlAHMAcwAgAFAAcgBvAHQAbwBjAG8AbAAgACgAVABBAFAAKQAgAGwAZQB0AHMAIAB5AG8AdQAgAGUAeABlAGMAdQB0AGUAIABxAHUAZQByAGkAZQBzACAAYQBnAGEAaQBuAHMAdAAgAG8AdQByAAoAZABhAHQAYQBiAGEAcwBlACAAdABhAGIAbABlAHMALAAgAGkAbgBzAHAAZQBjAHQAIAB2AGEAcgBpAG8AdQBzACAAbQBlAHQAYQBkAGEAdABhACwAIABhAG4AZAAgAHUAcABsAG8AYQBkACAAeQBvAHUAcgAgAG8AdwBuAAoAZABhAHQAYQAuACAAIAAKAAoASQBuACAARwBBAFYATwAnAHMAIABkAGEAdABhACAAYwBlAG4AdABlAHIALAAgAHcAZQAgAGkAbgAgAHAAYQByAHQAaQBjAHUAbABhAHIAIABoAG8AbABkACAAcwBlAHYAZQByAGEAbAAgAGwAYQByAGcAZQAKAGMAYQB0AGEAbABvAGcAcwAgAGwAaQBrAGUAIABQAFAATQBYAEwALAAgADIATQBBAFMAUwAgAFAAUwBDACwAIABVAFMATgBPAC0AQgAyACwAIABVAEMAQQBDADQALAAgAFcASQBTAEUALAAgAFMARABTAFMAIABEAFIAMQA2ACwACgBIAFMATwBZACwAIABhAG4AZAAgAHMAZQB2AGUAcgBhAGwAIABHAGEAaQBhACAAZABhAHQAYQAgAHIAZQBsAGUAYQBzAGUAcwAgAGEAbgBkACAAYQBuAGMAaQBsAGwAYQByAHkAIAByAGUAcwBvAHUAcgBjAGUAcwAgAGYAbwByAAoAeQBvAHUAIAB0AG8AIAB1AHMAZQAgAGkAbgAgAGMAcgBvAHMAcwBtAGEAdABjAGgAZQBzACwAIABwAG8AcwBzAGkAYgBsAHkAIAB3AGkAdABoACAAdQBwAGwAbwBhAGQAZQBkACAAdABhAGIAbABlAHMALgAKAAoAVABhAGIAbABlAHMAIABlAHgAcABvAHMAZQBkACAAdABoAHIAbwB1AGcAaAAgAHQAaABpAHMAIABlAG4AZABwAG8AaQBuAHQAIABpAG4AYwBsAHUAZABlADoAIABuAHUAYwBhAG4AZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbQBhAG4AZABhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAG4AbgBpAHMAcgBlAGQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgB0AGEAcgBlAHMAMQAwACAAcwBjAGgAZQBtAGEALAAgAGQAcgAxADAAIABmAHIAbwBtACAAdABoAGUAIABhAHAAYQBzAHMAIABzAGMAaABlAG0AYQAsACAAZgByAGEAbQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABhAHAAbwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQBwAHAAbABhAHUAcwBlACAAcwBjAGgAZQBtAGEALAAgAGcAZgBoACwAIABpAGQALAAgAGkAZABlAG4AdABpAGYAaQBlAGQALAAgAG0AYQBzAHQAZQByACwAIABuAGkAZAAsACAAdQBuAGkAZABlAG4AdABpAGYAaQBlAGQAIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBnAGYAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQByAGkAaABpAHAAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAdQBnAGUAcgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABwAGgAbwB0AF8AYQBsAGwALAAgAHMAcwBhAF8AdABpAG0AZQBfAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAYgBnAGQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYgBvAHkAZABlAG4AZABlACAAcwBjAGgAZQBtAGEALAAgAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYgByAG8AdwBuAGQAdwBhAHIAZgBzACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAZgBsAHUAeABwAG8AcwB2ADEAMgAwADAALAAgAGYAbAB1AHgAcABvAHMAdgA1ADAAMAAsACAAZgBsAHUAeAB2ADEAMgAwADAALAAgAGYAbAB1AHgAdgA1ADAAMAAsACAAbwBiAGoAZQBjAHQAcwAsACAAcwBwAGUAYwB0AHIAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBsAGkAZgBhAGQAcgAzACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABzAHIAYwBjAGEAdAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAIABzAGMAaABlAG0AYQAsACAAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQByAHMAYQByAGMAcwAgAHMAYwBoAGUAbQBhACwAIABsAGkAbgBlAF8AdABhAHAAIABmAHIAbwBtACAAdABoAGUAIABjAGEAcwBhAF8AbABpAG4AZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAG4AcwA1AHUAcABkAGEAdABlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABjAHMAOAAyAG0AbwByAHAAaABvAHoAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AIABmAHIAbwBtACAAdABoAGUAIABjAHMAdABsACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABkAGEAbgBpAHMAaAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBwAGwAYQB0AGUAcwAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBfAHMAcABlAGMAdAByAGEALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAZABmAGIAcwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAG0AdQBiAGkAbgAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZQBtAGkAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABmAGsANgBqAG8AaQBuACwAIABwAGEAcgB0ADEALAAgAHAAYQByAHQAMwAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAawA2ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQByAGUAXwBzAHUAcgB2AGUAeQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABvAHIAZABlAHIAcwBtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBsAGEAcwBoAGgAZQByAG8AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBvAHIAbgBhAHgAIABzAGMAaABlAG0AYQAsACAAZAByADIAXwB0AHMAXwBzAHMAYQAsACAAZAByADIAZQBwAG8AYwBoAGYAbAB1AHgALAAgAGQAcgAyAGwAaQBnAGgAdAAsACAAZAByADMAbABpAHQAZQAsACAAZQBkAHIAMwBsAGkAdABlACAAZgByAG8AbQAgAHQAaABlACAAZwBhAGkAYQAgAHMAYwBoAGUAbQBhACwAIABoAHkAYQBjAG8AYgAsACAAbQBhAGcAbABpAG0AcwA1ACwAIABtAGEAZwBsAGkAbQBzADYALAAgAG0AYQBnAGwAaQBtAHMANwAsACAAbQBhAGkAbgAsACAAbQBpAHMAcwBpAG4AZwBfADEAMABtAGEAcwAsACAAcgBlAGoAZQBjAHQAZQBkACwAIAByAGUAcwBvAGwAdgBlAGQAcwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBjAG4AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZwBjAHAAbQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGEAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMgBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHAAaABvAHQAbwBtAGUAdAByAHkAIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAsACAAdwBpAHQAaABwAG8AcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADMAcwBwAGUAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAGEAdQB0AG8AIABzAGMAaABlAG0AYQAsACAAbABpAHQAZQB3AGkAdABoAGQAaQBzAHQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAZABpAHMAdAAgAHMAYwBoAGUAbQBhACwAIABnAGUAbgBlAHIAYQB0AGUAZABfAGQAYQB0AGEALAAgAG0AYQBnAGwAaQBtAF8ANQAsACAAbQBhAGcAbABpAG0AXwA2ACwAIABtAGEAZwBsAGkAbQBfADcALAAgAG0AYQBpAG4ALAAgAHAAYQByAHMAZQBjAF8AcAByAG8AcABzACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAG0AbwBjAGsAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBzAHAAdQByACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAHMAZQByAHYAaQBjAGUAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGwAbwB0AHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAcABzADEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAZABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABoAGkAaQBjAG8AdQBuAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAGkAcABwAGEAcgBjAG8AcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABwAHAAdQBuAGkAbwBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHMAbwB5ACAAcwBjAGgAZQBtAGEALAAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAaQBjAGUAYwB1AGIAZQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAaQBuAGYAbABpAGcAaAB0ACAAcwBjAGgAZQBtAGEALAAgAG8AYgBzAF8AcgBhAGQAaQBvACwAIABvAGIAcwBjAG8AcgBlACAAZgByAG8AbQAgAHQAaABlACAAaQB2AG8AYQAgAHMAYwBoAGUAbQBhACwAIABlAHYAZQBuAHQAcwAsACAAcABoAG8AdABwAG8AaQBuAHQAcwAsACAAdABpAG0AZQBzAGUAcgBpAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAMgBjADkAdgBzAHQAIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMAIABmAHIAbwBtACAAdABoAGUAIABrAGEAcAB0AGUAeQBuACAAcwBjAGgAZQBtAGEALAAgAGsAYQB0AGsAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAawBhAHQAawBhAHQAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADUAIABzAGMAaABlAG0AYQAsACAAcwBzAGEAXwBsAHIAcwAsACAAcwBzAGEAXwBtAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAYQBtAG8AcwB0ADYAIABzAGMAaABlAG0AYQAsACAAZABpAHMAawBfAGIAYQBzAGkAYwAsACAAaABfAGwAaQBuAGsALAAgAGkAZABlAG4AdAAsACAAbQBlAHMAXwBiAGkAbgBhAHIAeQAsACAAbQBlAHMAXwBtAGEAcwBzAF8AcABsACwAIABtAGUAcwBfAG0AYQBzAHMAXwBzAHQALAAgAG0AZQBzAF8AcgBhAGQAaQB1AHMAXwBzAHQALAAgAG0AZQBzAF8AcwBlAHAAXwBhAG4AZwAsACAAbQBlAHMAXwB0AGUAZgBmAF8AcwB0ACwAIABvAGIAagBlAGMAdAAsACAAcABsAGEAbgBlAHQAXwBiAGEAcwBpAGMALAAgAHAAcgBvAHYAaQBkAGUAcgAsACAAcwBvAHUAcgBjAGUALAAgAHMAdABhAHIAXwBiAGEAcwBpAGMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZgBlAF8AdABkACAAcwBjAGgAZQBtAGEALAAgAGcAZQBvAGMAbwB1AG4AdABzACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwB0AGEAdABpAG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAGcAaAB0AG0AZQB0AGUAcgAgAHMAYwBoAGUAbQBhACwAIAByAGEAdwBmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQB2AGUAcgBwAG8AbwBsACAAcwBjAGgAZQBtAGEALAAgAHIAbQB0AGEAYgBsAGUALAAgAHMAcABlAGMAdAByAGEALAAgAHMAcwBhAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABsAG8AdABzAHMAcABvAGwAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwBwAG0AIABzAGMAaABlAG0AYQAsACAAcABsAGEAdABlAHMALAAgAHcAbwBsAGYAcABhAGwAaQBzAGEAIABmAHIAbwBtACAAdABoAGUAIABsAHMAdwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbQBhAGcAaQBjACAAcwBjAGgAZQBtAGEALAAgAHIAZQBkAHUAYwBlAGQAIABmAHIAbwBtACAAdABoAGUAIABtAGEAaQBkAGEAbgBhAGsAIABzAGMAaABlAG0AYQAsACAAZQB4AHQAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYwBlAHgAdABpAG4AYwB0ACAAcwBjAGgAZQBtAGEALAAgAGMAdQBiAGUAcwAsACAAcwBsAGkAdABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAbQBsAHEAcwBvACAAcwBjAGgAZQBtAGEALAAgAGUAcABuAF8AYwBvAHIAZQAsACAAbQBwAGMAbwByAGIAIABmAHIAbwBtACAAdABoAGUAIABtAHAAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIABzAHQAYQByAHMAIABmAHIAbwBtACAAdABoAGUAIABtAHcAcwBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAZQAxADQAYQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbwBiAHMAYwBvAGQAZQAgAHMAYwBoAGUAbQBhACwAIABiAGkAYgByAGUAZgBzACwAIABtAGEAcABzACwAIABtAGEAcwBlAHIAcwAsACAAbQBvAG4AaQB0AG8AcgAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AaABtAGEAcwBlAHIAIABzAGMAaABlAG0AYQAsACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMALAAgAHMAcwBhACAAZgByAG8AbQAgAHQAaABlACAAbwBuAGUAYgBpAGcAYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACwAIABzAGgAYQBwAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG8AcABlAG4AbgBnAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAYwBjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAGMAMwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABsAHQAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABvAGwAYwBhAHQAcwBtAGMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABtAGEAcABzACAAZgByAG8AbQAgAHQAaABlACAAcABwAGEAawBtADMAMQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAcABwAG0AeAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACwAIAB1AHMAbgBvAGMAbwByAHIAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4AGwAIABzAGMAaABlAG0AYQAsACAAbQBhAHAAMQAwACwAIABtAGEAcAA2ACwAIABtAGEAcAA3ACwAIABtAGEAcAA4ACwAIABtAGEAcAA5ACwAIABtAGEAcABfAHUAbgBpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcgBkAHUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGQAcgAyACwAIABkAHIAMwAsACAAZAByADQALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAByAGEAdgBlACAAcwBjAGgAZQBtAGEALAAgAGkAbQBhAGcAZQBzACwAIABwAGgAbwB0AG8AbgBzACAAZgByAG8AbQAgAHQAaABlACAAcgBvAHMAYQB0ACAAcwBjAGgAZQBtAGEALAAgAGEAbAB0AF8AaQBkAGUAbgB0AGkAZgBpAGUAcgAsACAAYQB1AHQAaABvAHIAaQB0AGkAZQBzACwAIABjAGEAcABhAGIAaQBsAGkAdAB5ACwAIABnAF8AbgB1AG0AXwBzAHQAYQB0ACwAIABpAG4AdABlAHIAZgBhAGMAZQAsACAAaQBuAHQAZgBfAHAAYQByAGEAbQAsACAAcgBlAGcAaQBzAHQAcgBpAGUAcwAsACAAcgBlAGwAYQB0AGkAbwBuAHMAaABpAHAALAAgAHIAZQBzAF8AZABhAHQAZQAsACAAcgBlAHMAXwBkAGUAdABhAGkAbAAsACAAcgBlAHMAXwByAG8AbABlACwAIAByAGUAcwBfAHMAYwBoAGUAbQBhACwAIAByAGUAcwBfAHMAdQBiAGoAZQBjAHQALAAgAHIAZQBzAF8AdABhAGIAbABlACwAIAByAGUAcwBvAHUAcgBjAGUALAAgAHMAdABjAF8AcwBwAGEAdABpAGEAbAAsACAAcwB0AGMAXwBzAHAAZQBjAHQAcgBhAGwALAAgAHMAdABjAF8AdABlAG0AcABvAHIAYQBsACwAIABzAHUAYgBqAGUAYwB0AF8AdQBhAHQALAAgAHQAYQBiAGwAZQBfAGMAbwBsAHUAbQBuACwAIAB0AGEAcABfAHQAYQBiAGwAZQAsACAAdgBhAGwAaQBkAGEAdABpAG8AbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAcgAgAHMAYwBoAGUAbQBhACwAIABvAGIAagBlAGMAdABzACwAIABwAGgAbwB0AHAAYQByACAAZgByAG8AbQAgAHQAaABlACAAcwBhAHMAbQBpAHIAYQBsAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHMAZABzAHMAZAByADEANgAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIANwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBtAGEAawBjAGUAZAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAGUAYwBpAGUAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBwAG0ANAAgAHMAYwBoAGUAbQBhACwAIABzAG8AdQByAGMAZQBzACAAZgByAG8AbQAgAHQAaABlACAAcwB1AHAAZQByAGMAbwBzAG0AbwBzACAAcwBjAGgAZQBtAGEALAAgAGMAbwBsAHUAbQBuAHMALAAgAGcAcgBvAHUAcABzACwAIABrAGUAeQBfAGMAbwBsAHUAbQBuAHMALAAgAGsAZQB5AHMALAAgAHMAYwBoAGUAbQBhAHMALAAgAHQAYQBiAGwAZQBzACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAXwBzAGMAaABlAG0AYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABhAHAAdABlAHMAdAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdABlAG4AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGcAYQBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB0AGgAZQBvAHMAcwBhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAbwBzAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAdwBvAG0AYQBzAHMAIABzAGMAaABlAG0AYQAsACAAaQBjAHIAcwBjAG8AcgByACwAIABtAGEAaQBuACwAIABwAHAAbQB4AGwAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwAzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQByAGEAdAAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAbABhAHQAZQBjAG8AcgByAHMALAAgAHAAbABhAHQAZQBzACwAIABwAHAAbQB4AGMAcgBvAHMAcwAsACAAcwBwAHUAcgBpAG8AdQBzACwAIAB0AHcAbwBtAGEAcwBzAGMAcgBvAHMAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAcwBuAG8AYgAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdgBlAHIAbwBuAHEAcwBvAHMAIABzAGMAaABlAG0AYQAsACAAcwB0AHIAaQBwAGUAOAAyACAAZgByAG8AbQAgAHQAaABlACAAdgBsAGEAcwB0AHIAaQBwAGUAOAAyACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGQAcwBkAHMAcwAxADAAIABzAGMAaABlAG0AYQAsACAAYQByAGMAaABpAHYAZQBzACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdwBmAHAAZABiACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGkAcwBlACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB4AHAAcABhAHIAYQBtAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHoAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAuAAAAN2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2luZm8AAAAQAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAAAATMjAwOS0xMi0wMVQxMDowMDowMAAAABMyMDI0LTAyLTA2VDEwOjE5OjMzAAAAAAAAAAAAAAAAAAAAAH/AAAAAAAAAAAABWGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy90YXAvcnVuL2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvdGFwAAAA2Gl2bzovL2l2b2EubmV0L3N0ZC9kYWxpI2V4YW1wbGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3RhcAAAAHl2cjp3ZWJicm93c2VyOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAASDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAADw6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAA
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E new file mode 100644 index 00000000..1590ca4d --- /dev/null +++ b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E @@ -0,0 +1,23 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAEXZzOmNhdGFsb2dzZXJ2aWNlAAAAC0dBVk8gREMgVEFQAAAAHABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAVABBAFAAIABzAGUAcgB2AGkAYwBlAAAAAAAAFBkAVABoAGUAIABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACcAcwAgAFQAQQBQACAAZQBuAGQAIABwAG8AaQBuAHQALgAgACAACgBUAGgAZQAgAFQAYQBiAGwAZQAgAEEAYwBjAGUAcwBzACAAUAByAG8AdABvAGMAbwBsACAAKABUAEEAUAApACAAbABlAHQAcwAgAHkAbwB1ACAAZQB4AGUAYwB1AHQAZQAgAHEAdQBlAHIAaQBlAHMAIABhAGcAYQBpAG4AcwB0ACAAbwB1AHIACgBkAGEAdABhAGIAYQBzAGUAIAB0AGEAYgBsAGUAcwAsACAAaQBuAHMAcABlAGMAdAAgAHYAYQByAGkAbwB1AHMAIABtAGUAdABhAGQAYQB0AGEALAAgAGEAbgBkACAAdQBwAGwAbwBhAGQAIAB5AG8AdQByACAAbwB3AG4ACgBkAGEAdABhAC4AIAAgAAoACgBJAG4AIABHAEEAVgBPACcAcwAgAGQAYQB0AGEAIABjAGUAbgB0AGUAcgAsACAAdwBlACAAaQBuACAAcABhAHIAdABpAGMAdQBsAGEAcgAgAGgAbwBsAGQAIABzAGUAdgBlAHIAYQBsACAAbABhAHIAZwBlAAoAYwBhAHQAYQBsAG8AZwBzACAAbABpAGsAZQAgAFAAUABNAFgATAAsACAAMgBNAEEAUwBTACAAUABTAEMALAAgAFUAUwBOAE8ALQBCADIALAAgAFUAQwBBAEMANAAsACAAVwBJAFMARQAsACAAUwBEAFMAUwAgAEQAUgAxADYALAAKAEgAUwBPAFkALAAgAGEAbgBkACAAcwBlAHYAZQByAGEAbAAgAEcAYQBpAGEAIABkAGEAdABhACAAcgBlAGwAZQBhAHMAZQBzACAAYQBuAGQAIABhAG4AYwBpAGwAbABhAHIAeQAgAHIAZQBzAG8AdQByAGMAZQBzACAAZgBvAHIACgB5AG8AdQAgAHQAbwAgAHUAcwBlACAAaQBuACAAYwByAG8AcwBzAG0AYQB0AGMAaABlAHMALAAgAHAAbwBzAHMAaQBiAGwAeQAgAHcAaQB0AGgAIAB1AHAAbABvAGEAZABlAGQAIAB0AGEAYgBsAGUAcwAuAAoACgBUAGEAYgBsAGUAcwAgAGUAeABwAG8AcwBlAGQAIAB0AGgAcgBvAHUAZwBoACAAdABoAGkAcwAgAGUAbgBkAHAAbwBpAG4AdAAgAGkAbgBjAGwAdQBkAGUAOgAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAYQBtAGEAbgBkAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgBuAGkAcwByAGUAZAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAxADAAIABzAGMAaABlAG0AYQAsACAAZAByADEAMAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABvACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHAAcABsAGEAdQBzAGUAIABzAGMAaABlAG0AYQAsACAAZwBmAGgALAAgAGkAZAAsACAAaQBkAGUAbgB0AGkAZgBpAGUAZAAsACAAbQBhAHMAdABlAHIALAAgAG4AaQBkACwAIAB1AG4AaQBkAGUAbgB0AGkAZgBpAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcgBpAGcAZgBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBoAGkAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQB1AGcAZQByACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAaABvAHQAXwBhAGwAbAAsACAAcwBzAGEAXwB0AGkAbQBlAF8AcwBlAHIAaQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABiAGcAZABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABiAG8AeQBkAGUAbgBkAGUAIABzAGMAaABlAG0AYQAsACAAYwBhAHQAIABmAHIAbwBtACAAdABoAGUAIABiAHIAbwB3AG4AZAB3AGEAcgBmAHMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABmAGwAdQB4AHAAbwBzAHYAMQAyADAAMAAsACAAZgBsAHUAeABwAG8AcwB2ADUAMAAwACwAIABmAGwAdQB4AHYAMQAyADAAMAAsACAAZgBsAHUAeAB2ADUAMAAwACwAIABvAGIAagBlAGMAdABzACwAIABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAGwAaQBmAGEAZAByADMAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHMAcgBjAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwAgAHMAYwBoAGUAbQBhACwAIABtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwBhAHIAYwBzACAAcwBjAGgAZQBtAGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBzAGEAXwBsAGkAbgBlAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAdQBwAGQAYQB0AGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwA4ADIAbQBvAHIAcABoAG8AegAgAHMAYwBoAGUAbQBhACwAIABnAGUAbwAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwB0AGwAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAYQBuAGkAcwBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHAAbABhAHQAZQBzACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AF8AcwBwAGUAYwB0AHIAYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHMAcABlAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAbQB1AGIAaQBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABlAG0AaQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGYAawA2AGoAbwBpAG4ALAAgAHAAYQByAHQAMQAsACAAcABhAHIAdAAzACAAZgByAG8AbQAgAHQAaABlACAAZgBrADYAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAbABhAHIAZQBfAHMAdQByAHYAZQB5ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAG8AcgBkAGUAcgBzAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQBzAGgAaABlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAG8AcgBuAGEAeAAgAHMAYwBoAGUAbQBhACwAIABkAHIAMgBfAHQAcwBfAHMAcwBhACwAIABkAHIAMgBlAHAAbwBjAGgAZgBsAHUAeAAsACAAZAByADIAbABpAGcAaAB0ACwAIABkAHIAMwBsAGkAdABlACwAIABlAGQAcgAzAGwAaQB0AGUAIABmAHIAbwBtACAAdABoAGUAIABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGgAeQBhAGMAbwBiACwAIABtAGEAZwBsAGkAbQBzADUALAAgAG0AYQBnAGwAaQBtAHMANgAsACAAbQBhAGcAbABpAG0AcwA3ACwAIABtAGEAaQBuACwAIABtAGkAcwBzAGkAbgBnAF8AMQAwAG0AYQBzACwAIAByAGUAagBlAGMAdABlAGQALAAgAHIAZQBzAG8AbAB2AGUAZABzAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGMAbgBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABnAGMAcABtAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAYQBwACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGQAaQBzAHQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcABoAG8AdABvAG0AZQB0AHIAeQAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABzAHAAZQBjAHQAcgBhACwAIABzAHMAYQBtAGUAdABhACwAIAB3AGkAdABoAHAAbwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAYQB1AHQAbwAgAHMAYwBoAGUAbQBhACwAIABsAGkAdABlAHcAaQB0AGgAZABpAHMAdAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGcAZQBuAGUAcgBhAHQAZQBkAF8AZABhAHQAYQAsACAAbQBhAGcAbABpAG0AXwA1ACwAIABtAGEAZwBsAGkAbQBfADYALAAgAG0AYQBnAGwAaQBtAF8ANwAsACAAbQBhAGkAbgAsACAAcABhAHIAcwBlAGMAXwBwAHIAbwBwAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAHMAcAB1AHIAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAcwBlAHIAdgBpAGMAZQBzACwAIAB0AGEAYgBsAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAbABvAHQAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBwAHMAMQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABkAGcAYQBpAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBpAGMAbwB1AG4AdABlAHIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBwAHAAYQByAGMAbwBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHAAcAB1AG4AaQBvAG4AIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAcwBvAHkAIABzAGMAaABlAG0AYQAsACAAbgB1AGMAYQBuAGQAIABmAHIAbwBtACAAdABoAGUAIABpAGMAZQBjAHUAYgBlACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABpAG4AZgBsAGkAZwBoAHQAIABzAGMAaABlAG0AYQAsACAAbwBiAHMAXwByAGEAZABpAG8ALAAgAG8AYgBzAGMAbwByAGUAIABmAHIAbwBtACAAdABoAGUAIABpAHYAbwBhACAAcwBjAGgAZQBtAGEALAAgAGUAdgBlAG4AdABzACwAIABwAGgAbwB0AHAAbwBpAG4AdABzACwAIAB0AGkAbQBlAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAawAyAGMAOQB2AHMAdAAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAYQBwAHQAZQB5AG4AIABzAGMAaABlAG0AYQAsACAAawBhAHQAawBhAHQAIABmAHIAbwBtACAAdABoAGUAIABrAGEAdABrAGEAdAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANQAgAHMAYwBoAGUAbQBhACwAIABzAHMAYQBfAGwAcgBzACwAIABzAHMAYQBfAG0AcgBzACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANgAgAHMAYwBoAGUAbQBhACwAIABkAGkAcwBrAF8AYgBhAHMAaQBjACwAIABoAF8AbABpAG4AawAsACAAaQBkAGUAbgB0ACwAIABtAGUAcwBfAGIAaQBuAGEAcgB5ACwAIABtAGUAcwBfAG0AYQBzAHMAXwBwAGwALAAgAG0AZQBzAF8AbQBhAHMAcwBfAHMAdAAsACAAbQBlAHMAXwByAGEAZABpAHUAcwBfAHMAdAAsACAAbQBlAHMAXwBzAGUAcABfAGEAbgBnACwAIABtAGUAcwBfAHQAZQBmAGYAXwBzAHQALAAgAG8AYgBqAGUAYwB0ACwAIABwAGwAYQBuAGUAdABfAGIAYQBzAGkAYwAsACAAcAByAG8AdgBpAGQAZQByACwAIABzAG8AdQByAGMAZQAsACAAcwB0AGEAcgBfAGIAYQBzAGkAYwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQBmAGUAXwB0AGQAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AYwBvAHUAbgB0AHMALAAgAG0AZQBhAHMAdQByAGUAbQBlAG4AdABzACwAIABzAHQAYQB0AGkAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZwBoAHQAbQBlAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AGYAcgBhAG0AZQBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAHYAZQByAHAAbwBvAGwAIABzAGMAaABlAG0AYQAsACAAcgBtAHQAYQBiAGwAZQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAbwB0AHMAcwBwAG8AbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbABzAHAAbQAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAsACAAdwBvAGwAZgBwAGEAbABpAHMAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwB3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABtAGEAZwBpAGMAIABzAGMAaABlAG0AYQAsACAAcgBlAGQAdQBjAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYQBpAGQAYQBuAGEAawAgAHMAYwBoAGUAbQBhACwAIABlAHgAdABzACAAZgByAG8AbQAgAHQAaABlACAAbQBjAGUAeAB0AGkAbgBjAHQAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABzAGwAaQB0AHMAcABlAGMAdAByAGEAIABmAHIAbwBtACAAdABoAGUAIABtAGwAcQBzAG8AIABzAGMAaABlAG0AYQAsACAAZQBwAG4AXwBjAG8AcgBlACwAIABtAHAAYwBvAHIAYgAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcwB0AGEAcgBzACAAZgByAG8AbQAgAHQAaABlACAAbQB3AHMAYwBlADEANABhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABvAGIAcwBjAG8AZABlACAAcwBjAGgAZQBtAGEALAAgAGIAaQBiAHIAZQBmAHMALAAgAG0AYQBwAHMALAAgAG0AYQBzAGUAcgBzACwAIABtAG8AbgBpAHQAbwByACAAZgByAG8AbQAgAHQAaABlACAAbwBoAG0AYQBzAGUAcgAgAHMAYwBoAGUAbQBhACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABvAG4AZQBiAGkAZwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHMAaABhAHAAZQBzACAAZgByAG8AbQAgAHQAaABlACAAbwBwAGUAbgBuAGcAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcABjAGMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAbABjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAyACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAdABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAG8AbABjAGEAdABzAG0AYwAgAHMAYwBoAGUAbQBhACwAIABjAHUAYgBlAHMALAAgAG0AYQBwAHMAIABmAHIAbwBtACAAdABoAGUAIABwAHAAYQBrAG0AMwAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHUAcwBuAG8AYwBvAHIAcgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcABtAHgAbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAcAAxADAALAAgAG0AYQBwADYALAAgAG0AYQBwADcALAAgAG0AYQBwADgALAAgAG0AYQBwADkALAAgAG0AYQBwAF8AdQBuAGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcAByAGQAdQBzAHQAIABzAGMAaABlAG0AYQAsACAAZAByADIALAAgAGQAcgAzACwAIABkAHIANAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAYQB2AGUAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHAAaABvAHQAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIAByAG8AcwBhAHQAIABzAGMAaABlAG0AYQAsACAAYQBsAHQAXwBpAGQAZQBuAHQAaQBmAGkAZQByACwAIABhAHUAdABoAG8AcgBpAHQAaQBlAHMALAAgAGMAYQBwAGEAYgBpAGwAaQB0AHkALAAgAGcAXwBuAHUAbQBfAHMAdABhAHQALAAgAGkAbgB0AGUAcgBmAGEAYwBlACwAIABpAG4AdABmAF8AcABhAHIAYQBtACwAIAByAGUAZwBpAHMAdAByAGkAZQBzACwAIAByAGUAbABhAHQAaQBvAG4AcwBoAGkAcAAsACAAcgBlAHMAXwBkAGEAdABlACwAIAByAGUAcwBfAGQAZQB0AGEAaQBsACwAIAByAGUAcwBfAHIAbwBsAGUALAAgAHIAZQBzAF8AcwBjAGgAZQBtAGEALAAgAHIAZQBzAF8AcwB1AGIAagBlAGMAdAAsACAAcgBlAHMAXwB0AGEAYgBsAGUALAAgAHIAZQBzAG8AdQByAGMAZQAsACAAcwB0AGMAXwBzAHAAYQB0AGkAYQBsACwAIABzAHQAYwBfAHMAcABlAGMAdAByAGEAbAAsACAAcwB0AGMAXwB0AGUAbQBwAG8AcgBhAGwALAAgAHMAdQBiAGoAZQBjAHQAXwB1AGEAdAAsACAAdABhAGIAbABlAF8AYwBvAGwAdQBtAG4ALAAgAHQAYQBwAF8AdABhAGIAbABlACwAIAB2AGEAbABpAGQAYQB0AGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcgByACAAcwBjAGgAZQBtAGEALAAgAG8AYgBqAGUAYwB0AHMALAAgAHAAaABvAHQAcABhAHIAIABmAHIAbwBtACAAdABoAGUAIABzAGEAcwBtAGkAcgBhAGwAYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIAMQA2ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAGQAcwBzAGQAcgA3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAG0AYQBrAGMAZQBkACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAZQBjAGkAZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAbQA0ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAHUAcABlAHIAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAZwByAG8AdQBwAHMALAAgAGsAZQB5AF8AYwBvAGwAdQBtAG4AcwAsACAAawBlAHkAcwAsACAAcwBjAGgAZQBtAGEAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcABfAHMAYwBoAGUAbQBhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcAB0AGUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGUAbgBwAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAZwBhAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAaABlAG8AcwBzAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAbABpAG4AZQBfAHQAYQBwACAAZgByAG8AbQAgAHQAaABlACAAdABvAHMAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdAB3AG8AbQBhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABpAGMAcgBzAGMAbwByAHIALAAgAG0AYQBpAG4ALAAgAHAAcABtAHgAbABjAHIAbwBzAHMAIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AHIAYQB0ADEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAcABsAGEAdABlAGMAbwByAHIAcwAsACAAcABsAGEAdABlAHMALAAgAHAAcABtAHgAYwByAG8AcwBzACwAIABzAHAAdQByAGkAbwB1AHMALAAgAHQAdwBvAG0AYQBzAHMAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBzAG4AbwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB2AGUAcgBvAG4AcQBzAG8AcwAgAHMAYwBoAGUAbQBhACwAIABzAHQAcgBpAHAAZQA4ADIAIABmAHIAbwBtACAAdABoAGUAIAB2AGwAYQBzAHQAcgBpAHAAZQA4ADIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAZABzAGQAcwBzADEAMAAgAHMAYwBoAGUAbQBhACwAIABhAHIAYwBoAGkAdgBlAHMALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGYAcABkAGIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAaQBzAGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHgAcABwAGEAcgBhAG0AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAegBjAG8AcwBtAG8AcwAgAHMAYwBoAGUAbQBhAC4AAAA3aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDA5LTEyLTAxVDEwOjAwOjAwAAAAEzIwMjQtMDItMDZUMTA6MTk6MzMAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAFYaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vZXhhbXBsZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi90YWJsZU1ldGFkYXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXAAAADYaXZvOi8vaXZvYS5uZXQvc3RkL2RhbGkjZXhhbXBsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSN0YWJsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNjYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNhdmFpbGFiaWxpdHk6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwAAAAeXZyOndlYmJyb3dzZXI6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHAAAABIOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkAAAAPDo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Og==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta similarity index 56% rename from pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEF3q1PoDg.meta rename to pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta index 73461fed6a2d18738423e4eccf7834b064b5deb3..f4dc32860a4ba98138dccb0ade9e7a3d307219e8 100644 GIT binary patch delta 129 zcmbOv{zQzWfn{psM3!HYzWI4N3PxrMZmCHMMg~SE3I>)|hNe~~#+$_% z^$qpR^iopG%nh~Elafq~(oz#AhcoSFHa0VzEX}C2*_`{FKTm5uuw!SVNgNS935kZJxlz#0UVkQz!rc delta 172 zcmaDNHc6bNfn{p@M3!HYAsMAQ3I-MmZmCHMMg~SE3Wi2jrsh_rW}C$s z^$qpR^iopGj7_!EO^hs3%nX2BkYWQP1B=PNOuLy)3=B7OGe2gOxpMwUYH3o2N9~l1 z6fX#;hb1XLrE*F{{'siaarea0': <pgsphere PositionInterval Unknown 115.9428322966 -29.05 116.0571677034 -28.95>, '_ra': 116.0, '_dec': -29.0, '_sra': 0.1, -'_sdec': 0.1, 'format0': frozenset({'image/fits', 'image/jpeg', -'application/x-votable+xml;content=datalink'})}Written by DaCHS 2.9.2 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataWritten by DaCHS 2.9.2 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataLegal conditions applicable to (parts of) the data containedContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceAccess key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageSurvey field observed.Effective exposure time (sum of exposure times of all images contributing here).Dataset identifier assigned by the publisherAAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBiJAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA2jAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCzWgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfrgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBe+gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEOgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCBFAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDElAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHvgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB3PAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHaAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+FwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD+DwEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgCAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjI3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJyiUsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjIyOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5ICp6IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA9ZwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBT5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEWfgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDInwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAAaAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/5BgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/98gEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2CQEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDxOgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDzKQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/k/AEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDPegEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIxVDA0OjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXMCp8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDTKwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjEzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaPXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC95gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjI0OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI3wEkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjuQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBm4wEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIxVDA0OjA1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXKJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjMxOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLC8HMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwBwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCrngEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWhgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFeQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCRxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCOnQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCenAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1dgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1egEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2vQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUkwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqNgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCN6QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6DAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCiTQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAsAAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjEzOjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaN18wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjBQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjI0OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI2O+wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKDwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjU4OjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUwi5EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkEwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjMzOjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL9uXUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjMyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLmlvIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjM3OjE0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSrAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBd7AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRRAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB2tQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/BIAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB7+wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBGBAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSfwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBxQgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkbQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBlqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6OQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHkQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjU4OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUyD+4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAH9wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBBGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhcAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCt5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjM0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJMJe0IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCoGgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjMzOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL/PdIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCREwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjMyOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCebwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjM3OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNQBhEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCI/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCpQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjU2OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZUE7i0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDK6AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjUzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRTIP7cAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgNQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjMwOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHo1niawAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBHxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjMxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLDsqIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOmQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDeawEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA4VDA0OjA1OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBXRWeIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfVAEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBTMwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCLGQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDWKAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDsqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZUgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBLSgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUbgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBR+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUyAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBsKQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjMgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9WEwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUwAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDIGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+cQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAKxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1HAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5IDCLkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKNAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjI3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJy6mIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBecwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBc3gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBdvwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+d+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB/UgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZAAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjI1OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI5pbwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjE1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FaQ4IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEZwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIxVDAzOjU3OjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUi5FAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRDwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjA2OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCsrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjE3OjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjUwOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRSBU9EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCkPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjI2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJJXOskAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaZAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjI2OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJQZykAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHlQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCQuQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC+bQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCKCwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3OAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5hQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo0gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4qAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5WAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAU+QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE2VDA2OjU1OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCS1QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0EgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqYwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBA6wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDC0gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/n+QEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAyOjQ2OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7UAYQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgYgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZLQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB11AEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDMfQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI0VDAxOjMxOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4goM5QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaCgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDN5QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBORwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBNDAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRngEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSJQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBMKwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBL0QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9IAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZ4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjI0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQl7QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBifgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcKgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfgQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjIzOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHoy/hqMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBJiAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDA4wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC66QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDLAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjI0OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQNp0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCXlAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCSwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCx8gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDjKgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDnjwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjM0OjE4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP23LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBABdgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/7fAEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/6QQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBACKgEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/9mAEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDS0QEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEJTwEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD49gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwuwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI0VDAxOjMxOjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4golKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo/wEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBunwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1pwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfJwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBf2wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCCTwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBpWQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBtvgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCEawEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBg6QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmtgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBIpwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE2VDA2OjU1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTlEpUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBx9gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBByIwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhQwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgvAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE1LTAzLTIwVDAyOjQ2OjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7ToG0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+VLgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBvrQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBPVQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB8ggEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmXAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjM0OjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP22zY8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKwwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjI5OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKdZIEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBXmAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjI1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjUwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRR/z3QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBaOwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjE3OjI2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGMtIcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjA2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXlc60AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmLwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIxVDAzOjU3OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUgncYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBYeQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjE1OjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FZgVQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBOzgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGVgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCh8wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGgwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjQ2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRQc0t4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3CwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjQ4OjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZRU9D4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCG4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCbnwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjI5OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKeJq8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdNAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjI1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI6Z+sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6
This service lets you access cutouts from BGDS images and retrieve +:bibcode:`2015AN....336..590H`.">Legal conditions applicable to (parts of) the data containedContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceAccess key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageSurvey field observed.Effective exposure time (sum of exposure times of all images contributing here).Dataset identifier assigned by the publisherAAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBiJAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA2jAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCzWgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfrgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBe+gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEOgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCBFAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDElAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHvgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB3PAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHaAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+FwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD+DwEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgCAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjI3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJyiUsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjIyOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5ICp6IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA9ZwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBT5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEWfgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDInwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAAaAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/5BgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/98gEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2CQEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDxOgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDzKQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/k/AEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDPegEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIxVDA0OjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXMCp8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDTKwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjEzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaPXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC95gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjI0OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI3wEkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjuQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBm4wEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIxVDA0OjA1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXKJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjMxOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLC8HMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwBwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCrngEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWhgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFeQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCRxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCOnQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCenAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1dgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1egEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2vQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUkwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqNgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCN6QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6DAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCiTQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAsAAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjEzOjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaN18wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjBQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjI0OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI2O+wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKDwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjU4OjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUwi5EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkEwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjMzOjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL9uXUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjMyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLmlvIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjM3OjE0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSrAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBd7AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRRAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB2tQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/BIAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB7+wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBGBAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSfwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBxQgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkbQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBlqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6OQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHkQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjU4OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUyD+4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAH9wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBBGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhcAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCt5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjM0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJMJe0IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCoGgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjMzOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL/PdIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCREwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjMyOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCebwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjM3OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNQBhEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCI/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCpQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjU2OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZUE7i0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDK6AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjUzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRTIP7cAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgNQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjMwOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHo1niawAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBHxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjMxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLDsqIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOmQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDeawEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA4VDA0OjA1OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBXRWeIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfVAEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBTMwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCLGQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDWKAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDsqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZUgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBLSgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUbgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBR+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUyAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBsKQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjMgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9WEwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUwAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDIGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+cQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAKxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1HAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5IDCLkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKNAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjI3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJy6mIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBecwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBc3gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBdvwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+d+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB/UgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZAAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjI1OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI5pbwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjE1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FaQ4IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEZwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIxVDAzOjU3OjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUi5FAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRDwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjA2OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCsrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjE3OjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjUwOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRSBU9EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCkPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjI2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJJXOskAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaZAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjI2OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJQZykAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHlQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCQuQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC+bQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCKCwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3OAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5hQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo0gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4qAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5WAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAU+QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE2VDA2OjU1OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCS1QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0EgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqYwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBA6wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDC0gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/n+QEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAyOjQ2OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7UAYQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgYgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZLQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB11AEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDMfQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI0VDAxOjMxOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4goM5QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaCgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDN5QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBORwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBNDAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRngEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSJQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBMKwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBL0QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9IAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZ4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjI0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQl7QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBifgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcKgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfgQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjIzOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHoy/hqMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBJiAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDA4wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC66QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDLAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjI0OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQNp0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCXlAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCSwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCx8gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDjKgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDnjwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjM0OjE4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP23LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBABdgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/7fAEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/6QQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBACKgEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/9mAEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDS0QEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEJTwEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD49gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwuwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI0VDAxOjMxOjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4golKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo/wEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBunwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1pwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfJwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBf2wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCCTwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBpWQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBtvgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCEawEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBg6QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmtgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBIpwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE2VDA2OjU1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTlEpUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBx9gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBByIwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhQwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgvAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE1LTAzLTIwVDAyOjQ2OjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7ToG0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+VLgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBvrQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBPVQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB8ggEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmXAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjM0OjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP22zY8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKwwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjI5OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKdZIEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBXmAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjI1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjUwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRR/z3QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBaOwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjE3OjI2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGMtIcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjA2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXlc60AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmLwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIxVDAzOjU3OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUgncYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBYeQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjE1OjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FZgVQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBOzgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGVgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCh8wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGgwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjQ2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRQc0t4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3CwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjQ4OjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZRU9D4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCG4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCbnwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjI5OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKeJq8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdNAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjI1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI6Z+sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6
This service lets you access cutouts from BGDS images and retrieve scaled versions. \ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta b/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta index 2c46f1413b170e186ad1e80714a17f80aa642d24..9ad919b2adc34c549f558fc7517e0b6d6c528b9f 100644 GIT binary patch delta 96 zcmcc5yPub(fo1BJi7fv`jLa0=Qj-*n42(<^3@ojTjjT+KHj6XvW)v4Is4U6I&(keR zEi6qfE-BVG(lfHqGu+I@EW;#lB0Vy^x0_qH?EXl~v(>K;LG}JRv(D2F3E3MGn{E|tANnq~1 c1F5A+87{R`G7`LioXw)FevFKMlT+EE0F1jQxBvhE diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi deleted file mode 100644 index 103c4621..00000000 --- a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi +++ /dev/null @@ -1,23 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.An identifier for the resource or an entity related to the resource in URI form.AAAAHGl2bzovL29yZy5nYXZvLmRjL2JnZHMvcS9zaWEAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAIYmdkcyBzaWEAAAApAEIAbwBjAGgAdQBtACAARwBhAGwAYQBjAHQAaQBjACAARABpAHMAawAgAFMAdQByAHYAZQB5ACAAKABCAEcARABTACkAIABpAG0AYQBnAGUAcwAAAAhyZXNlYXJjaAAAAgsAVABoAGUAIABCAG8AYwBoAHUAbQAgAEcAYQBsAGEAYwB0AGkAYwAgAEQAaQBzAGsAIABTAHUAcgB2AGUAeQAgAGkAcwAgAGEAbgAgAG8AbgBnAG8AaQBuAGcAIABwAHIAbwBqAGUAYwB0ACAAdABvACAAbQBvAG4AaQB0AG8AcgAgAHQAaABlAAoAcwB0AGUAbABsAGEAcgAgAGMAbwBuAHQAZQBuAHQAIABvAGYAIAB0AGgAZQAgAEcAYQBsAGEAYwB0AGkAYwAgAGQAaQBzAGsAIABpAG4AIABhACAANgAgAGQAZQBnAHIAZQBlACAAdwBpAGQAZQAgAHMAdAByAGkAcABlAAoAYwBlAG4AdABlAHIAZQBkACAAbwBuACAAdABoAGUAIABHAGEAbABhAGMAdABpAGMAIABwAGwAYQBuAGUALgAgAFQAaABlACAAZABhAHQAYQAgAGgAYQBzACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAHMAaQBuAGMAZQAKAG0AaQBkAC0AMgAwADEAMAAgAGkAbgAgAFMAbABvAGEAbgAgAHIAIABhAG4AZAAgAGkAIABzAGkAbQB1AGwAdABhAG4AZQBvAHUAcwBsAHkAIAB3AGkAdABoACAAdABoAGUAIABSAG8AQgBvAFQAVAAgAFQAZQBsAGUAYwBzAG8AcABlACAAYQB0AAoAdABoAGUAIABVAG4AaQB2AGUAcgBzAGkAdABhAGUAdABzAHMAdABlAHIAbgB3AGEAcgB0AGUAIABCAG8AYwBoAHUAbQAgAG4AZQBhAHIAIABDAGUAcgByAG8AIABBAHIAbQBhAHoAbwBuAGUAcwAgAGkAbgAgAHQAaABlACAAQwBoAGkAbABlAGEAbgAKAEEAdABhAGMAYQBtAGEAIABkAGUAcwBlAHIAdAAuACAASQB0ACAAYwBvAG4AdABhAGkAbgBzACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABvAGYAIABhAGIAbwB1AHQAIAAyAHgAMQAwAF4ANwAgAHMAdABhAHIAcwAgAG8AdgBlAHIACgBtAG8AcgBlACAAdABoAGEAbgAgAHMAZQB2AGUAbgAgAHkAZQBhAHIAcwAuACAAQQBkAGQAaQB0AGkAbwBuAGEAbABsAHkALAAgAGkAbgB0AGUAcgBtAGkAdAB0AGUAbgB0ACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABpAG4ACgBKAG8AaABuAHMAbwBuACAAVQBWAEIAIABhAG4AZAAgAFMAbABvAGEAbgAgAHoAIABoAGEAdgBlACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAGEAcwAgAHcAZQBsAGwALgAAAC9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvaW5mbwAAACwASABhAGMAawBzAHQAZQBpAG4ALAAgAE0ALgA7ACAASABhAGEAcwAsACAATQAuADsAIABGAGUAaQBuACwAIABDAC4AOwAgAEMAaABpAG4AaQAsACAAUgAuAAAAEzIwMTctMTItMDJUMDk6MTY6MDAAAAATMjAyMy0wMi0wOVQxNDozMToxMQAAAEBJZiB5b3UgdXNlIEdEUyBkYXRhLCBwbGVhc2UgY2l0ZQo6YmliY29kZTpgMjAxNUFOLi4uLjMzNi4uNTkwSGAuAAAABnN1cnZleQAAAAdiaWJjb2RlAAAAEwAyADAAMQA1AEEATgAuAC4ALgAuADMAMwA2AC4ALgA1ADkAMABIf8AAAAAAAAdvcHRpY2FsAAAB6Wh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsbWV0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsZ2V0Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL3NpYS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9CR0RTOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9iZ2RzL3Evc2lhL3NpYXAueG1sPwAAAURpdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NvZGEjc3luYy0xLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eDo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAADKdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnI6d2ViYnJvd3Nlcjo6OnB5IFZPIHNlcDo6OnZzOnBhcmFtaHR0cAAAAH5zdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjpzdGQAAABpOjo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6AAAAAA==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB new file mode 100644 index 00000000..414f956a --- /dev/null +++ b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB @@ -0,0 +1,23 @@ + +ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_level. +The terms are taken from the vocabulary +http://ivoa.net/rdf/voresource/content_type. +The allowed values for waveband include: +Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL2JnZHMvcS9zaWEAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAIYmdkcyBzaWEAAAApAEIAbwBjAGgAdQBtACAARwBhAGwAYQBjAHQAaQBjACAARABpAHMAawAgAFMAdQByAHYAZQB5ACAAKABCAEcARABTACkAIABpAG0AYQBnAGUAcwAAAAhyZXNlYXJjaAAAAgsAVABoAGUAIABCAG8AYwBoAHUAbQAgAEcAYQBsAGEAYwB0AGkAYwAgAEQAaQBzAGsAIABTAHUAcgB2AGUAeQAgAGkAcwAgAGEAbgAgAG8AbgBnAG8AaQBuAGcAIABwAHIAbwBqAGUAYwB0ACAAdABvACAAbQBvAG4AaQB0AG8AcgAgAHQAaABlAAoAcwB0AGUAbABsAGEAcgAgAGMAbwBuAHQAZQBuAHQAIABvAGYAIAB0AGgAZQAgAEcAYQBsAGEAYwB0AGkAYwAgAGQAaQBzAGsAIABpAG4AIABhACAANgAgAGQAZQBnAHIAZQBlACAAdwBpAGQAZQAgAHMAdAByAGkAcABlAAoAYwBlAG4AdABlAHIAZQBkACAAbwBuACAAdABoAGUAIABHAGEAbABhAGMAdABpAGMAIABwAGwAYQBuAGUALgAgAFQAaABlACAAZABhAHQAYQAgAGgAYQBzACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAHMAaQBuAGMAZQAKAG0AaQBkAC0AMgAwADEAMAAgAGkAbgAgAFMAbABvAGEAbgAgAHIAIABhAG4AZAAgAGkAIABzAGkAbQB1AGwAdABhAG4AZQBvAHUAcwBsAHkAIAB3AGkAdABoACAAdABoAGUAIABSAG8AQgBvAFQAVAAgAFQAZQBsAGUAYwBzAG8AcABlACAAYQB0AAoAdABoAGUAIABVAG4AaQB2AGUAcgBzAGkAdABhAGUAdABzAHMAdABlAHIAbgB3AGEAcgB0AGUAIABCAG8AYwBoAHUAbQAgAG4AZQBhAHIAIABDAGUAcgByAG8AIABBAHIAbQBhAHoAbwBuAGUAcwAgAGkAbgAgAHQAaABlACAAQwBoAGkAbABlAGEAbgAKAEEAdABhAGMAYQBtAGEAIABkAGUAcwBlAHIAdAAuACAASQB0ACAAYwBvAG4AdABhAGkAbgBzACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABvAGYAIABhAGIAbwB1AHQAIAAyAHgAMQAwAF4ANwAgAHMAdABhAHIAcwAgAG8AdgBlAHIACgBtAG8AcgBlACAAdABoAGEAbgAgAHMAZQB2AGUAbgAgAHkAZQBhAHIAcwAuACAAQQBkAGQAaQB0AGkAbwBuAGEAbABsAHkALAAgAGkAbgB0AGUAcgBtAGkAdAB0AGUAbgB0ACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABpAG4ACgBKAG8AaABuAHMAbwBuACAAVQBWAEIAIABhAG4AZAAgAFMAbABvAGEAbgAgAHoAIABoAGEAdgBlACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAGEAcwAgAHcAZQBsAGwALgAAAC9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvaW5mbwAAACwASABhAGMAawBzAHQAZQBpAG4ALAAgAE0ALgA7ACAASABhAGEAcwAsACAATQAuADsAIABGAGUAaQBuACwAIABDAC4AOwAgAEMAaABpAG4AaQAsACAAUgAuAAAAEzIwMTctMTItMDJUMDk6MTY6MDAAAAATMjAyMy0wMi0wOVQxNDozMToxMQAAAEBJZiB5b3UgdXNlIEdEUyBkYXRhLCBwbGVhc2UgY2l0ZQo6YmliY29kZTpgMjAxNUFOLi4uLjMzNi4uNTkwSGAuAAAABnN1cnZleQAAAAdiaWJjb2RlAAAAEwAyADAAMQA1AEEATgAuAC4ALgAuADMAMwA2AC4ALgA1ADkAMABIf8AAAAAAAAdvcHRpY2FsAAAB6Wh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsbWV0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsZ2V0Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL3NpYS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9CR0RTOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9iZ2RzL3Evc2lhL3NpYXAueG1sPwAAAURpdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NvZGEjc3luYy0xLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eDo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAADKdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnI6d2ViYnJvd3Nlcjo6OnB5IFZPIHNlcDo6OnZzOnBhcmFtaHR0cAAAAH5zdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjpzdGQAAABpOjo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta similarity index 59% rename from pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEMf93yIhi.meta rename to pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta index ce5bfe96cb3608de1fe46fb28b8ac0542e94dc10..29a3f9a689e6ef29d5e684cbb9b747f216ad4cc2 100644 GIT binary patch delta 123 zcmca2woHtrfn}=nM3(;|MrI0bsYwb(21X_d29{QardGxlo5dOB7$tNID#QHs4fV|Q zQc}yz4Ykvgl1z-!QWGbKGwoqAFrF;UsI=Lf`5>druCP0)rAZkcwNo-uydaz&mZbcY Y$|(`zn?+bdnKxH+9A(@b#Kpu20KN()Qvd(} delta 166 zcmZ1`c14V(fn}=aM3(;|2Br#bsYwb(21X_dhQ?NghE}F#o5dOB7?sQmD#QHs4fV|Q zQc}x|jkVJ)O_D53QjPUeK#C2F3`{5cGVNh9w%p9k{FqT@&bOriginal ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.
\ No newline at end of file + ">Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta index b93b2561993f739d8f2a613ff6f2c37e69569146..98a27ac82f737722da1d4e09a0ff21808151d1ad 100644 GIT binary patch delta 371 zcmbOrF+pMjGoy%+nSxttl7f+ek%@wVrIoRfm8s!oaYk)MQFBA>^rR#cqqNjSy%dnV zfsv8f}qB zG%3TQc1lKy7lhNpl9ZoPImPJ~D+7bBE+Jzk^Ra16u45G^XdhVNT~GZ!}-BLE1)XFUJ_ diff --git a/pyvo/registry/tests/data/capabilities.xml b/pyvo/registry/tests/data/capabilities.xml index 1baeebd2..031e9760 100644 --- a/pyvo/registry/tests/data/capabilities.xml +++ b/pyvo/registry/tests/data/capabilities.xml @@ -1,87 +1,162 @@ - + - - - - http://example.org/tap/availability - https://example.org/tap/availability - - - - - http://example.org/tap/capabilities - https://example.org/tap/capabilities - - - - - http://example.org/tap/tables - https://example.org/tap/tables - - - - - http://example.org/tap - https://example.org/tap - - Obscore-1.1 - Registry 1.0 - GloTS 1.0 - Obscore-1.0 - - ADQL - 2.0 - ADQL 2.0 - - -
form 1
- description 1 -
- -
form 2
- description 2 -
-
- - -
BOX
-
- -
POINT
-
-
- - -
TABLESAMPLE
- Written after a table reference, ... -
- -
MOC
- A geometry function creating MOCs... -
-
-
- - text/xml - - - text/html - html - - - - - 172800 - - - 3600 - - - 2000 - 10000000 - - - 100000000 - -
-
+http://dc.zah.uni-heidelberg.de/taphttps://dc.zah.uni-heidelberg.de/tapGloTS 1.0Registry 1.1Obscore-1.1ADQL2.02.1The Astronomical Data Query Language is the standard IVOA dialect of SQL; it contains a very general SELECT statement as well as some extensions for spherical geometry and higher mathematics.
gavo_apply_pm(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmde DOUBLE PRECISION, epdist DOUBLE PRECISION) -> POINT
Returns a POINT (in the UNDEFINED reference frame) for the position +an object at ra/dec with proper motion pmra/pmde has after epdist years. + +positions must be in degrees, PMs in should be in julian years (i.e., proper +motions are expected in degrees/year). pmra is assumed to contain +cos(delta). + +This function goes through the tangential plane. Since it does not have +information on distance and radial velocity, it cannot reconstruct +the true space motion, and hence its results will degrade over time. + +This function should not be used in new queries; use ivo_epoch_prop +instead.
gavo_getauthority(ivoid TEXT) -> TEXT
returns the authority part of an ivoid (or, more generally a URI). +So, ivo://org.gavo.dc/foo/bar#baz becomes org.gavo.dc. + +The behaviour for anything that's not a full URI is undefined.
gavo_ipix(long REAL, lat REAL) -> BIGINT
gavo_ipix returns the q3c ipix for a long/lat pair (it simply wraps +the 13c_ang2ipix function). + +This is probably only relevant when you play tricks with indices or +PPMXL ids.
gavo_match(pattern TEXT, string TEXT) -> INTEGER
gavo_match returns 1 if the POSIX regular expression pattern +matches anything in string, 0 otherwise.
gavo_mocintersect(moc1 MOC, moc2 MOC) -> MOC
returns the intersection of two MOCs.
gavo_mocunion(moc1 MOC, moc2 MOC) -> MOC
returns the union of two MOCs.
gavo_specconv(expr DOUBLE PRECISION, dest_unit TEXT) -> DOUBLE PRECISION
returns the spectral value expr converted to dest_unit. + +expr has to be in either energy, wavelength, or frequency, and dest_unit +must be a VOUnit giving another spectral unit (e.g., MHz, keV, nm, or +Angstrom). This is intended to let users express spectral constraints +in their preferred unit independently of the choice of unit in the +database. Examples:: + + gavo_specconv(obscore.em_min, "keV") > 300 + gavo_specconv(obscore.em_max, "MHz") > 30 + gavo_specconv(spectral_start, "Angstrom") > 4000 + +There is a variant of gavo_specconv accepting expr's unit in a third +argument.
gavo_specconv(expr NUMERIC, expr_unit TEXT, dest_unit TEXT) -> NUMERIC
returns expr assumed to be in expr_unit expressed in dest_unit. + + This is a variant of the two-argument gavo_specconv for when + the unit of expr is not known to the ADQL translator, either because + it because it is a literal or because it does not look like + a spectral unit. Examples:: + + gavo_specconv(656, 'nm', 'J') BETWEEN spectral_start AND spectral_end + gavo_specconv(arccos(phi)*incidence, 'Hz', 'eV') + + Clearly, overriding known units is likely to yield bad results; + the translator therefore warns if an existing unit is overridden + with a different unit.
gavo_vocmatch(vocname TEXT, term TEXT, matchagainst TEXT) -> INTEGER
returns 1 if matchagainst is term or narrower in the IVOA vocabulary +vocname, 0 otherwise. + +This is intended for semantic querying. For instance, +gavo_vocmatch('datalink/core', 'calibration', semantics) would be 1 +if semantics is any of calibration, bias, dark, or flat. + +For RDF-flavoured vocabularies (strict trees), term will expand to the +entire branch rooted in term. For SKOS-flavoured vocabularies (where +narrower is not transitive), only directly narrower terms will be included. + +Both the term and the vocabulary name must be string literals (i.e., +constants). matchagainst can be any string-valued expression.
ivo_epoch_prop(ra DOUBLE PRECISION, dec DOUBLE PRECISION, parallax DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, radial_velocity DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> DOUBLE PRECISION[6]
Returns a 6-vector of (ra, dec, parallax, pmra, pmdec, rv) +at out_epoch for these quantities at ref_epoch. + +Essentially, it will apply the proper motion under the assumption of +linear motion. Despite the name of the positional parameters, this is +not restricted to equatorial systems, as long as positions and proper +motions are expressed in the same reference frames. + +Units on input and output are degrees for ra and dec, mas for parallax, +mas/yr for pmra and pmdec, and km/s for the radial velocity. + +ref_epoch and out_epoch are given in Julian years. + +parallax, pmra, pmdec, and radial_velocity may be None and will enter +the computations as 0 then, except in the case of parallax, which +will be some small value. When abs(parallax) is smaller or equal +to that small value, parallax and radial velocity will be NULL on +output. + +In daily use, you probably want to use the ivo_epoch_prop_pos functions.
ivo_epoch_prop_pos(ra DOUBLE PRECISION, dec DOUBLE PRECISION, parallax DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, radial_velocity DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> POINT
Returns a POINT giving the position at out_epoch for an object +with the six parameters at ref_epoch. + +Essentially, it will apply the proper motion under the assumption of +linear motion. Despite the name of the positional parameters, this is +not restricted to equatorial systems, as long as positions and proper +motions are expressed in the same reference frames. + +Units on input are degrees for ra and dec, mas for parallax, +mas/yr for pmra and pmdec, and km/s for the radial velocity. +ref_epoch and out_epoch are given in Julian years. + +parallax, pmra, pmdec, and radial_velocity may be None and will enter +the computations as 0 then, except in the case of parallax, which +will be some small value.
ivo_epoch_prop_pos(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> POINT
A variant of ivo_epoch_prop_pos that behave as if parallax + and radial_velocity were both passed as NULL.
ivo_geom_transform(from_sys TEXT, to_sys TEXT, geo GEOMETRY) -> GEOMETRY
The function transforms ADQL geometries between various reference systems. +geo can be a POINT, a CIRCLE, or a POLYGON, and the function will return a +geometry of the same type. In the current implementation, from_sys and +to_sys must be literal strings (i.e., they cannot be computed through +expressions or be taken from database columns). + +All transforms are just simple rotations, which is only a rough +approximation to the actual relationships between reference systems +(in particular between FK4 and ICRS-based ones). Note that, in particular, +the epoch is not changed (i.e., no proper motions are applied). + +We currently support the following reference frames: ICRS, FK5 (which +is treated as ICRS), FK4 (for B1950. without epoch-dependent corrections), +GALACTIC. Reference frame names are case-sensitive.
ivo_hashlist_has(hashlist TEXT, item TEXT) -> INTEGER
The function takes two strings; the first is a list of words not +containing the hash sign (#), concatenated by hash signs, the second is +a word not containing the hash sign. It returns 1 if, compared +case-insensitively, the second argument is in the list of words coded in +the first argument. The behaviour in case the the second +argument contains a hash sign is unspecified.
ivo_hasword(haystack TEXT, needle TEXT) -> INTEGER
gavo_hasword returns 1 if needle shows up in haystack, 0 otherwise. This +is for "google-like"-searches in text-like fields. In word, you can +actually employ a fairly complex query language; see +https://www.postgresql.org/docs/current/textsearch.html +for details.
ivo_healpix_center(hpxOrder INTEGER, hpxIndex BIGINT) -> POINT
returns a POINT corresponding to the center of the healpix with +the given index at the given order.
ivo_healpix_index(order INTEGER, ra DOUBLE PRECISION, dec DOUBLE PRECISION) -> BIGINT
Returns the index of the (nest) healpix with order containing the +spherical point (ra, dec). + +An alternative, 2-argument form + +ivo_healpix_index(order INTEGER, p POINT) -> BIGINT + +is also available.
ivo_histogram(val REAL, lower REAL, upper REAL, nbins INTEGER) -> INTEGER[]
The aggregate function returns a histogram of val with nbins+2 elements. +Assuming 0-based arrays, result[0] contains the number of underflows (i.e., +val<lower), result[nbins+1] the number of overflows. Elements 1..nbins +are the counts in nbins bins of width (upper-lower)/nbins. Clients +will have to convert back to physical units using some external +communication, there currently is no (meta-) data as lower and upper in +the TAP response.
ivo_interval_has(val NUMERIC, iv INTERVAL) -> INTEGER
The function returns 1 if the interval iv contains val, 0 otherwise. +The lower limit is always included in iv, behaviour on the upper +limit is column-specific.
ivo_interval_overlaps(l1 NUMERIC, h1 NUMERIC, l2 NUMERIC, h2 NUMERIC) -> INTEGER
The function returns 1 if the interval [l1...h1] overlaps with +the interval [l2...h2]. For the purposes of this function, +the case l1=h2 or l2=h1 is treated as overlap. The function +returns 0 for non-overlapping intervals.
ivo_nocasematch(value TEXT, pattern TEXT) -> INTEGER
ivo_nocasematch returns 1 if pattern matches value, 0 otherwise. +pattern is defined as for the SQL LIKE operator, but the +match is performed case-insensitively. This function in effect +provides a surrogate for the ILIKE SQL operator that is missing from +ADQL. + +On this site, this is actually implemented using python's and SQL's +LOWER, so for everything except ASCII, your mileage will vary.
ivo_normal_random(mu REAL, sigma REAL) -> REAL
The function returns a random number drawn from a normal distribution +with mean mu and width sigma. + +Implementation note: Right now, the Gaussian is approximated by +summing up and scaling ten calls to random. This, hence, is not +very precise or fast. It might work for some use cases, and we +will provide a better implementation if this proves inadequate.
ivo_simbadpoint(identifier TEXT) -> POINT
gavo_simbadpoint queries simbad for an identifier and returns the +corresponding point. Note that identifier can only be a literal, +i.e., as simple string rather than a column name. This is because +our database cannot query simbad, and we probably wouldn't want +to fire off millions of simbad queries anyway; use simbad's own +TAP service for this kind of application.
ivo_string_agg(expression TEXT, delimiter TEXT) -> TEXT
An aggregate function returning all values of +expression within a GROUP contcatenated with delimiter
ivo_to_jd(d TIMESTAMP) -> DOUBLE PRECISION
The function converts a postgres timestamp to julian date. +This is naive; no corrections for timezones, let alone time +scales or the like are done; you can thus not expect this to be +good to second-precision unless you are careful in the construction +of the timestamp.
ivo_to_mjd(d TIMESTAMP) -> DOUBLE PRECISION
The function converts a postgres timestamp to modified julian date. +This is naive; no corrections for timezones, let alone time +scales or the like are done; you can thus not expect this to be +good to second-precision unless you are careful in the construction +of the timestamp.
BOX
POINT
CIRCLE
POLYGON
REGION
CENTROID
COORD1
COORD2
DISTANCE
CONTAINS
INTERSECTS
AREA
LOWER
ILIKE
OFFSET
CAST
IN_UNIT
WITH
TABLESAMPLE
Written after a table reference, TABLESAMPLE(10) will make the database only use 10% of the rows; these are `somewhat random' in that the system will use random blocks. This should be good enough when just testing queries (and much better than using TOP n).
MOC
A geometry function creating MOCs. It either takes a string argument with an ASCII MOC ('4/13 17-18 8/3002'), or an order and another geometry.
COALESCE
This is the standard SQL COALESCE for providing defaults in case of NULL values.
VECTORMATH
You can compute with vectors here. See https://wiki.ivoa.net/twiki/bin/view/IVOA/ADQLVectorMath for an overview of the functions and operators available.
CASE
The SQL92 CASE expression
UNION
EXCEPT
INTERSECT
text/tab-separated-valuestsvtext/plaintxttext/csvcsv_baretext/csv;header=presentcsvapplication/jsonjsonapplication/geo+jsongeojsonapplication/x-votable+xmlvotableapplication/x-votable+xml;serialization=BINARY2votable/b2votableb2application/x-votable+xml;serialization=TABLEDATAtext/xmlvotable/tdvotabletdapplication/x-votable+xml;serialization=TABLEDATA;version=1.1text/xmlvotabletd1.1application/x-votable+xml;version=1.1text/xmlvotable1.1application/x-votable+xml;serialization=TABLEDATA;version=1.2text/xmlvotabletd1.2application/x-votable+xml;serialization=TABLEDATA;version=1.5vodmlapplication/x-votable+xml;version=1.5vodmlbtext/htmlhtmlapplication/fitsfits17280072002000016000000100000000
http://dc.zah.uni-heidelberg.de/__system__/tap/run/availabilityhttps://dc.zah.uni-heidelberg.de/__system__/tap/run/availabilityhttp://dc.zah.uni-heidelberg.de/__system__/tap/run/capabilitieshttps://dc.zah.uni-heidelberg.de/__system__/tap/run/capabilitieshttp://dc.zah.uni-heidelberg.de/__system__/tap/run/tableMetadatahttps://dc.zah.uni-heidelberg.de/__system__/tap/run/tableMetadatahttp://dc.zah.uni-heidelberg.de/__system__/tap/run/exampleshttps://dc.zah.uni-heidelberg.de/__system__/tap/run/examples
\ No newline at end of file diff --git a/pyvo/registry/tests/test_regtap.py b/pyvo/registry/tests/test_regtap.py index b85220b2..ac3cdb13 100644 --- a/pyvo/registry/tests/test_regtap.py +++ b/pyvo/registry/tests/test_regtap.py @@ -52,7 +52,7 @@ def callback(request, context): @pytest.fixture(name='regtap_pulsar_distance_response') -def _regtap_pulsar_distance_response(mocker, scope="session"): +def _regtap_pulsar_distance_response(mocker, capabilities, scope="session"): with mocker.register_uri( 'POST', REGISTRY_BASEURL + '/sync', content=get_pkg_data_contents('data/regtap.xml')) as matcher: @@ -60,7 +60,7 @@ def _regtap_pulsar_distance_response(mocker, scope="session"): @pytest.fixture() -def keywords_fixture(mocker, scope="session"): +def keywords_fixture(mocker, capabilities, scope="session"): def keywordstest_callback(request, context): data = dict(parse_qsl(request.body)) query = data['QUERY'] @@ -83,12 +83,13 @@ def keywordstest_callback(request, context): @pytest.fixture() -def single_keyword_fixture(mocker, scope="session"): +def single_keyword_fixture(mocker, capabilities, scope="session"): def keywordstest_callback(request, context): data = dict(parse_qsl(request.body)) query = data['QUERY'] - assert "OR rr.res_subject.res_subject ILIKE '%single%'" in query + assert (" UNION SELECT ivoid FROM rr.res_subject WHERE" + " rr.res_subject.res_subject ILIKE '%single%'") in query assert "1=ivo_hasword(res_description, 'single') " in query assert "1=ivo_hasword(res_title, 'single')" in query @@ -102,7 +103,7 @@ def keywordstest_callback(request, context): @pytest.fixture() -def servicetype_fixture(mocker, scope="session"): +def servicetype_fixture(mocker, capabilities, scope="session"): def servicetypetest_callback(request, context): data = dict(parse_qsl(request.body)) query = data['QUERY'] @@ -123,7 +124,7 @@ def servicetypetest_callback(request, context): @pytest.fixture() -def waveband_fixture(mocker, scope="session"): +def waveband_fixture(mocker, capabilities, scope="session"): def wavebandtest_callback(request, content): data = dict(parse_qsl(request.body)) query = data['QUERY'] @@ -140,7 +141,7 @@ def wavebandtest_callback(request, content): @pytest.fixture() -def datamodel_fixture(mocker, scope="session"): +def datamodel_fixture(mocker, capabilities, scope="session"): def datamodeltest_callback(request, content): data = dict(parse_qsl(request.body)) query = data['QUERY'] @@ -162,7 +163,7 @@ def datamodeltest_callback(request, content): @pytest.fixture() -def aux_fixture(mocker, scope="session"): +def aux_fixture(mocker, capabilities, scope="session"): def auxtest_callback(request, context): data = dict(parse_qsl(request.body)) query = data['QUERY'] @@ -179,7 +180,7 @@ def auxtest_callback(request, context): @pytest.fixture(name='multi_interface_fixture') -def _multi_interface_fixture(mocker, scope="session"): +def _multi_interface_fixture(mocker, capabilities, scope="session"): # to update this, run # import requests # from pyvo.registry import regtap From afafe3ef343a9b4163e71d94370ad98ccf60ad3d Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Wed, 20 Mar 2024 06:47:42 +0100 Subject: [PATCH 27/38] Whitespace edits to by-and-large placate flake8 --- pyvo/discover/image.py | 35 ++++++++-------- pyvo/discover/tests/test_imagediscovery.py | 46 ++++++++++++---------- pyvo/registry/regtap.py | 2 +- pyvo/registry/tests/test_rtcons.py | 12 +++--- 4 files changed, 51 insertions(+), 44 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index fe6d8fa1..40cab9e1 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -245,13 +245,14 @@ def ids(recs): # query. That's particularly valuable if there are large # obscore services covering data from many SIA1 services. ids_present = table.Table([ - table.Column(name="id", - data=list( - sorted(ids(self.sia1_recs) - | ids(self.sia2_recs) - | ids(self.obscore_recs))), - description="ivoids of candiate services", - meta={"ucd": "meta.ref.ivoid"}),]) + table.Column( + name="id", + data=list( + sorted(ids(self.sia1_recs) + | ids(self.sia2_recs) + | ids(self.obscore_recs))), + description="ivoids of candiate services", + meta={"ucd": "meta.ref.ivoid"}),]) if len(ids_present) == 0: return @@ -420,9 +421,8 @@ def non_spatial_filter(sia1_rec): # Regrettably, the exposure time is not part of SIA1 standard # metadata. We fudge things a bit; this should not # increase false positives very badly. - if (self.time_min is not None - or self.time_max is not None - ) and not self.inclusive and sia1_rec.dateobs: + if (self.time_min is not None or self.time_max is not None) \ + and not self.inclusive and sia1_rec.dateobs: if not (self.time_min-0.1 Tuple[List[obscore.ObsCoreMetadata], List[str]]: + services: Optional[registry.RegistryResults]=None)\ + -> Tuple[List[obscore.ObsCoreMetadata], List[str]]: """returns a collection of ObsCoreMetadata-s matching certain constraints and a list of log lines. diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 555d0cc3..57d95fa8 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -101,8 +101,8 @@ def test_sia2(self): d._query_one_sia2(queriable) assert set(queriable.search_kwargs) == set(["time"]) - assert abs(queriable.search_kwargs["time" - ][0].utc.value-40872.54166667)<1e-8 + assert abs(queriable.search_kwargs["time"][0].utc.value + -40872.54166667)<1e-8 def test_sia2_nointerval(self): queriable = FakeQueriable() @@ -111,23 +111,23 @@ def test_sia2_nointerval(self): d._query_one_sia2(queriable) assert set(queriable.search_kwargs) == set(["time"]) - assert abs(queriable.search_kwargs["time" - ][0].utc.value-40872.54166667)<1e-8 - assert abs(queriable.search_kwargs["time" - ][1].utc.value-40872.54166667)<1e-8 + assert abs(queriable.search_kwargs["time"][0].utc.value + -40872.54166667)<1e-8 + assert abs(queriable.search_kwargs["time"][1].utc.value + -40872.54166667)<1e-8 def test_obscore(self): queriable = FakeQueriable() d = discover.ImageDiscoverer( - time=( - time.Time("1970-10-13T13:00:00"), - time.Time("1970-10-13T17:00:00"))) + time=(time.Time("1970-10-13T13:00:00"), time.Time("1970-10-13T17:00:00"))) d.obscore_recs = [queriable] d._query_obscore() assert set(queriable.search_kwargs) == set() assert queriable.search_args[0] == ( - "select * from ivoa.obscore WHERE dataproduct_type='image' AND (t_max>=40872.541666666664 AND 40872.708333333336>=t_min AND t_min<=t_max AND 40872.541666666664<=40872.708333333336)") + "select * from ivoa.obscore WHERE dataproduct_type='image'" + " AND (t_max>=40872.541666666664 AND 40872.708333333336>=t_min" + " AND t_min<=t_max AND 40872.541666666664<=40872.708333333336)") def test_obscore_nointerval(self): queriable = FakeQueriable() @@ -139,7 +139,9 @@ def test_obscore_nointerval(self): assert set(queriable.search_kwargs) == set() assert queriable.search_args[0] == ( - "select * from ivoa.obscore WHERE dataproduct_type='image' AND (t_max>=40872.541666666664 AND 40872.541666666664>=t_min AND t_min<=t_max AND 40872.541666666664<=40872.541666666664)") + "select * from ivoa.obscore WHERE dataproduct_type='image'" + " AND (t_max>=40872.541666666664 AND 40872.541666666664>=t_min" + " AND t_min<=t_max AND 40872.541666666664<=40872.541666666664)") @pytest.fixture @@ -197,15 +199,17 @@ def _servedby_elision_responses(requests_mock): def test_servedby_elision(_servedby_elision_responses): d = discover.ImageDiscoverer(space=(3, 1, 0.2)) # siap2/sitewide has isservedby to tap - d.set_services(registry.search(registry.Ivoid( - "ivo://org.gavo.dc/tap", - "ivo://org.gavo.dc/__system__/siap2/sitewide"))) + d.set_services( + registry.search( + registry.Ivoid( + "ivo://org.gavo.dc/tap", + "ivo://org.gavo.dc/__system__/siap2/sitewide"))) assert d.sia2_recs == [] assert len(d.obscore_recs) == 1 assert d.obscore_recs[0].ivoid == "ivo://org.gavo.dc/tap" - assert ('Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because it is served by ivo://org.gavo.dc/tap' - in d.log_messages) + assert ('Skipping ivo://org.gavo.dc/__system__/siap2/sitewide' + ' because it is served by ivo://org.gavo.dc/tap' in d.log_messages) @pytest.fixture @@ -219,16 +223,18 @@ def test_access_url_elision(_access_url_elision_responses): d = discover.ImageDiscoverer( time=time.Time("1910-07-15", scale="utc"), spectrum=400*u.nm) - d.set_services(registry.search(registry.Ivoid( - "ivo://org.gavo.dc/tap", - "ivo://org.gavo.dc/__system__/siap2/sitewide")), + d.set_services( + registry.search( + registry.Ivoid( + "ivo://org.gavo.dc/tap", + "ivo://org.gavo.dc/__system__/siap2/sitewide")), # that's important here: we *want* to query the same stuff twice purge_redundant=False) d.query_services() # make sure we found anything at all assert d.results - assert len([1 for l in d.log_messages if "skipped" in l]) == 0 + assert len([1 for lm in d.log_messages if "skipped" in lm]) == 0 # make sure there are no duplicate records access_urls = [im.access_url for im in d.results] diff --git a/pyvo/registry/regtap.py b/pyvo/registry/regtap.py index 3a8d38e6..ca40c53e 100644 --- a/pyvo/registry/regtap.py +++ b/pyvo/registry/regtap.py @@ -524,7 +524,7 @@ def __init__(self, results, index, *, session=None): ] = self._parse_pseudo_array(self._mapping["access_urls"]) self._mapping["standard_ids"] = [ regularize_SIA2_id(id) for id in - self._parse_pseudo_array(self._mapping["standard_ids"])] + self._parse_pseudo_array(self._mapping["standard_ids"])] self._mapping["intf_types" ] = self._parse_pseudo_array(self._mapping["intf_types"]) self._mapping["intf_roles" diff --git a/pyvo/registry/tests/test_rtcons.py b/pyvo/registry/tests/test_rtcons.py index 543d0f7c..7144b9db 100644 --- a/pyvo/registry/tests/test_rtcons.py +++ b/pyvo/registry/tests/test_rtcons.py @@ -220,8 +220,8 @@ def test_junk_rejected(self): def test_obscore_new(self): cons = rtcons.Datamodel("obscore_new") assert (cons.get_search_condition(FAKE_GAVO) - == "table_utype like 'ivo://ivoa.net/std/obscore#table-1.%'" - " AND res_type = 'vs:catalogresource'") + == "table_utype like 'ivo://ivoa.net/std/obscore#table-1.%'" + " AND res_type = 'vs:catalogresource'") assert (cons._extra_tables == ["rr.res_table"]) def test_obscore(self): @@ -302,8 +302,8 @@ def test_moc(self): def test_moc_and_inclusive(self): cons = registry.Spatial("0/1-3 3/", inclusive=True) - assert cons.get_search_condition(FAKE_GAVO - ) == "1 = CONTAINS(MOC('0/1-3 3/'), coverage) OR coverage IS NULL" + assert cons.get_search_condition(FAKE_GAVO) == \ + "1 = CONTAINS(MOC('0/1-3 3/'), coverage) OR coverage IS NULL" def test_SkyCoord(self): cons = registry.Spatial(SkyCoord(3 * u.deg, -30 * u.deg)) @@ -406,8 +406,8 @@ def test_frequency_and_inclusive(self): cons = registry.Spectral(2 * u.GHz, inclusive=True) assert (cons.get_search_condition(FAKE_GAVO) == "(1.32521403e-24 BETWEEN spectral_start AND spectral_end)" - " OR NOT EXISTS(SELECT 1 FROM rr.stc_spectral AS inner_s" - " WHERE inner_s.ivoid=rr.resource.ivoid)") + " OR NOT EXISTS(SELECT 1 FROM rr.stc_spectral AS inner_s" + " WHERE inner_s.ivoid=rr.resource.ivoid)") def test_frequency_interval(self): cons = registry.Spectral((88 * u.MHz, 102 * u.MHz)) From 321c1219363047b2df167097e80887f14419b3e0 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 16 Apr 2024 16:13:58 +0200 Subject: [PATCH 28/38] functools.cache is 3.9+; replace it --- pyvo/discover/image.py | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 40cab9e1..a4aedaab 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -73,7 +73,7 @@ def __str__(self): return f"<{self.ivoid}>" -@functools.cache +@functools.lru_cache(maxsize=None) def obscore_column_names(): """returns the names of obscore columns. From 3ec9832529090cd4322784bc2a3701ea37574f72 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Mon, 6 May 2024 14:49:33 +0200 Subject: [PATCH 29/38] Removing LearnableRequestMocker and its infrastructure. It turns out that hashing actual network requests is too fragile -- due to version strings in headers and payloads, it is probably impossible to pull that off across python versions. I'm also dropping utils.testing; I think it might be useful to retain this in pyvo's history -- perhaps it will be useful as a basis for something comparable. Meanwhile, I have made the discovery tests remote_data. More unit tests ought to mock on a higher level, presumably by monkeypatching registry.search and the dal classes involved (yikes!). --- docs/utils/index.rst | 1 - docs/utils/testing.rst | 62 - pyvo/discover/image.py | 22 +- ...i-heidelberg.de-siap2.xml-d4zedJmw9oczzciY | 17 - ...delberg.de-siap2.xml-d4zedJmw9oczzciY.meta | Bin 1804 -> 0 bytes ...ah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S | 17 - ...i-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta | Bin 1831 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E | 23 - ...ST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta | Bin 2916 -> 0 bytes .../GET-reg.g-vo.org-capabilities-VYcr5usI | 162 -- ...ET-reg.g-vo.org-capabilities-VYcr5usI.meta | Bin 1504 -> 0 bytes .../GET-reg.g-vo.org-tables-Mffx+yRe | 1814 ----------------- .../GET-reg.g-vo.org-tables-Mffx+yRe.meta | Bin 1431 -> 0 bytes ...ah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO | 17 - ...i-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta | Bin 1910 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C | 28 - ...ST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta | Bin 3241 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU | 7 - ...ST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta | Bin 3249 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ | 27 - ...ST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta | Bin 3107 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm | 28 - ...ST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta | Bin 3204 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl | 27 - ...ST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta | Bin 3117 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill | 7 - ...ST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta | Bin 3161 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E | 23 - ...ST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta | Bin 2916 -> 0 bytes ...ni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk | 17 - ...idelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta | Bin 1727 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB | 23 - ...ST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta | Bin 2854 -> 0 bytes .../POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl | 7 - ...ST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta | Bin 3088 -> 0 bytes pyvo/discover/tests/test_imagediscovery.py | 57 +- 36 files changed, 32 insertions(+), 2354 deletions(-) delete mode 100644 docs/utils/testing.rst delete mode 100644 pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY delete mode 100644 pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E delete mode 100644 pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl delete mode 100644 pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta delete mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill delete mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta delete mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E delete mode 100644 pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta delete mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk delete mode 100644 pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl delete mode 100644 pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta diff --git a/docs/utils/index.rst b/docs/utils/index.rst index d8bc6d5a..4832ba5f 100644 --- a/docs/utils/index.rst +++ b/docs/utils/index.rst @@ -21,4 +21,3 @@ Reference/API :maxdepth: 1 prototypes - testing diff --git a/docs/utils/testing.rst b/docs/utils/testing.rst deleted file mode 100644 index 447f2f1e..00000000 --- a/docs/utils/testing.rst +++ /dev/null @@ -1,62 +0,0 @@ -.. _pyvo-testing: - -****************************************** -Helpers for Testing (`pyvo.utils.testing`) -****************************************** - -This package contains a few helpers to make testing pyVO code that does -a lot of network interaction simpler. -It is *not* intended to be used by user code or other libraries at -this point; the API might change at any time depending on the testing -needs of pyVO itself, and this documentation (mainly) addresses pyVO -developers. - - -The LearnableRequestMocker -========================== - -By its nature, much of pyVO is about talking to remote services. -Talking to these remote services in order to test pyVO code -makes test runs dependent on the status of external resources and may be -slow. It is therefore desirable to “can” responses to a large extent, -i.e., use live responses to define a test -fixture usable offline. This is what -`~pyvo.utils.testing.LearnableRequestMocker` tries to support. - -To use it, define a fixture for the mocker, somewhat like this:: - - @pytest.fixture - def _all_constraint_responses(requests_mock): - matcher = LearnableRequestMocker("image-with-all-constraints") - requests_mock.add_matcher(matcher) - -The first constructor argument is a fixture name that should be unique -among all the fixtures in a given subdirectory. - -When “training“ your mocker, run ``pytest --remote-data=any``. This -will create one or more pairs of files in the cache directory, which is -a sibling of the current file called ``data/``. Each -request produces two files: - -* .meta: a pickle of the request and selected response - metadata. You probably do not want to edit this. -* : the resonse body, which you may very well want to edit. - -All these must become part of the package for later tests to run without -network interaction. The is intended to facilitate figuring -out which response belongs to which request; it consists of the method, -the host, and hashes of the full URL and a payload. - -When the upstream response (or whatever request pyvo produces) changes, -remove the -cached files and re-run test with ``--remote-data=any``. - -We do not yet have a good plan for how to preserve edits made to the -test files. For now, commit the original responses, do any changes, and -do a commit encompassing only these changes. - - -Reference/API -============= - -.. automodapi:: pyvo.utils.testing diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index a4aedaab..50f8c0ee 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -424,8 +424,8 @@ def non_spatial_filter(sia1_rec): if (self.time_min is not None or self.time_max is not None) \ and not self.inclusive and sia1_rec.dateobs: if not (self.time_min-0.1 - Tuple[List[obscore.ObsCoreMetadata], List[str]]: """returns a collection of ObsCoreMetadata-s matching certain constraints and a list of log lines. diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY deleted file mode 100644 index 2a00c4b7..00000000 --- a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY +++ /dev/null @@ -1,17 +0,0 @@ - -Definition and support code for the ObsCore data model and table.{'BAND0': 4.0000000000000003e-07, 'TIME0': 18867.0}Written by DaCHS 2.9.2 SIAP2RendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. -The calib_level flag takes the following values: - -=== =========================================================== - 0 Raw Instrumental data requiring instrument-specific tools - 1 Instrumental data processable with standard tools - 2 Calibrated, science-ready data without instrument signature - 3 Enhanced data products (e.g., mosaics) -=== ===========================================================High level scientific classification of the data product, taken from an enumerationAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.AAAABWltYWdlAAEAAAAWUG90c2RhbSBLYXB0ZXluIFNlcmllcwAAACRrYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHMAAAAxUG90c2RhbSBLYXB0ZXluIFNlcmllcyA5MSBmb3IgMDdBIEthcHRleW4tU3BlY2lhbAAAADhpdm86Ly9vcmcuZ2F2by5kYy9+P2thcHRleW4vZGF0YS9maXRzL1BPVDA4MF8wMDAwOTEuZml0cwAAAAAAAABxaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9rYXB0ZXluL3EvZGwvZGxtZXRhP0lEPWl2bzovL29yZy5nYXZvLmRjL34lM0ZrYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHMAAAAmYXBwbGljYXRpb24veC12b3RhYmxlO2NvbnRlbnQ9ZGF0YWxpbmsAAAAAAAAACgAAABMwN0EgS2FwdGV5bi1TcGVjaWFsAAAABlJlZ2lvbkByXBBNR47fQD11dhs2AEo/c5JtPxh6vQAAAH9Qb2x5Z29uIElDUlMgMjk0LjA1NjgwMjUyNCAyOS4xNjYxMzk1MDk3IDI5My40NTQzMjcwMzg1IDI5LjE1ODAxMjk4MjEgMjkzLjQ0NDA0NjIwNDcgMjkuNzUzNzI5MDA1MyAyOTQuMDU2MDg4MTI3MSAyOS43NTk1NjY2OTgxP2GdYmIxCMhA0mzAAAAAAEDSbMAAAAAAf8AAAH/AAAA+mYBZrJmmhT6hcsQXx3Hvf/gAAAAAAAAAAAAGZW0ub3B0AAAAAAAAAApBTyBQb3RzZGFtAAAAGEdyZWF0IFJlZnJhY3RvciAtIFBPVDA4MAAAAAAAAB9AAAAAAAAAG7z///////////////////////////////8/YZ1iYjEIyAAAAAAAAABcaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L2thcHRleW4vZGF0YS9maXRzL1BPVDA4MF8wMDAwOTEuZml0cz9wcmV2aWV3PVRydWU=
A datalink service accompanying obscore. This will forward to data -collection-specific datalink services if they exist or return -extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta b/pyvo/discover/tests/data/access-url-elision/GET-dc.zah.uni-heidelberg.de-siap2.xml-d4zedJmw9oczzciY.meta deleted file mode 100644 index 366156c5fa0cad318d907cd1ef1745cdaea6abb2..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1804 zcmb7FVNV-J5T%X52-6r!8?|a9U8AakfY0Vg2vDJlVoDQ)g9ufnO4WAnZp>Xc-(7C^ zFph-Oe5s1M-@5%zRewW&OyAmP8x$(F{@~l0oteFz_ukykr9a*&PxOD6dQnw`5abBYKjS& zWTaKaOQMK88747uD$g^NB!3utjC1E@#$(Z@tVS`;4&zg;=1+#cy^*i%1$lf%zWxQ} z1!d=yVez6^+;8&TZ(r0Md((C-*$ssx|9f)lPQzZa8z!gZbBPx!HT#eIhe^C*IqTLp zQLXW0`F8ggCr=OewpTYc)}Ppo<>IM>cZ113?Sko` zvSc_llY<~Neu|!IHS?V@b_T}1w1?ZowP6Fm7-z#?HK0|w=TR!J(XhHR@Qg_~fBHI1 zS1g~}5ookxxtYnF8f0QINI;h!)*qUk84w{J&>sfy9~);xX^lrvPJ!<yPyn1druvW0P^gMiDJF8vwuJB^`vlhj9SWGe7C@Foxrk!ckOWc?^+;?a)XA zC)_KxV{vomO3jUTied*7>eI1PkYr&D8Sx0GMGouC{yJQG0mfEKRTyN%AUG))W($lcbZywk zSCu34JnjzwfV`+m<^o!M^lxg@>hu31IISkM+IM;E|4-G)5EJPw)umFuK~vc)bAP;~ zDU8dj+U?r4Zg*?0N~XTatQKcjLuK#7e-b6*`TV-!*`2~K3n=KcXRt6)(WEB diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S deleted file mode 100644 index 5cbe02c8..00000000 --- a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S +++ /dev/null @@ -1,17 +0,0 @@ - -Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. -The calib_level flag takes the following values: - -=== =========================================================== - 0 Raw Instrumental data requiring instrument-specific tools - 1 Instrumental data processable with standard tools - 2 Calibrated, science-ready data without instrument signature - 3 Enhanced data products (e.g., mosaics) -=== ===========================================================High level scientific classification of the data product, taken from an enumerationData product specific typeAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.Name of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.AAAABWltYWdlAAAAAAABAAAAFlBvdHNkYW0gS2FwdGV5biBTZXJpZXMAAAAka2FwdGV5bi9kYXRhL2ZpdHMvUE9UMDgwXzAwMDA5MS5maXRzAAAAMVBvdHNkYW0gS2FwdGV5biBTZXJpZXMgOTEgZm9yIDA3QSBLYXB0ZXluLVNwZWNpYWwAAAA4aXZvOi8vb3JnLmdhdm8uZGMvfj9rYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHMAAAAAAAAAcWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUva2FwdGV5bi9xL2RsL2RsbWV0YT9JRD1pdm86Ly9vcmcuZ2F2by5kYy9+JTNGa2FwdGV5bi9kYXRhL2ZpdHMvUE9UMDgwXzAwMDA5MS5maXRzAAAAJmFwcGxpY2F0aW9uL3gtdm90YWJsZTtjb250ZW50PWRhdGFsaW5rAAAAAAAAAAoAAAATMDdBIEthcHRleW4tU3BlY2lhbAAAAAZSZWdpb25AclwQTUeO30A9dXYbNgBKP3OSbT8Yer0AAAB/UG9seWdvbiBJQ1JTIDI5NC4wNTY4MDI1MjQgMjkuMTY2MTM5NTA5NyAyOTMuNDU0MzI3MDM4NSAyOS4xNTgwMTI5ODIxIDI5My40NDQwNDYyMDQ3IDI5Ljc1MzcyOTAwNTMgMjk0LjA1NjA4ODEyNzEgMjkuNzU5NTY2Njk4MT9hnWJiMQjIQNJswAAAAABA0mzAAAAAAH/AAAB/wAAAPpmAWayZpoU+oXLEF8dx73/4AAAAAAAAAAAABmVtLm9wdAAAAAAAAAAKQU8gUG90c2RhbQAAABhHcmVhdCBSZWZyYWN0b3IgLSBQT1QwODAAAAAAAAAfQAAAAAAAABu8////////////////////////////////P2GdYmIxCMgAAAAAAAAAXGh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9rYXB0ZXluL2RhdGEvZml0cy9QT1QwODBfMDAwMDkxLmZpdHM/cHJldmlldz1UcnVlAAAADmthcHRleW4ucGxhdGVz
A datalink service accompanying obscore. This will forward to data -collection-specific datalink services if they exist or return -extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta b/pyvo/discover/tests/data/access-url-elision/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKjhkIo60S.meta deleted file mode 100644 index bb04edabf323f7f4a7da2b7eb36a93d4dbb117f8..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1831 zcmaJ?QBNC35T?aoifMq-rmdPt?t>$U@!6acz(_n;*bPmH0Yj9wQnlKTl?e>FoK=4iD+Q?9S}W?Cg9q-~Cqj>p^iQ{ciNSDhY{YB9O~G zqF?;2iax;};X*fuKYMv@?3Y|dC84q=M=|&<9c1EpDt?ROI1F5D9#+4uT``HBkW{au z5PTEisA5($t-i|3ha%=)S`+;m>W}Ms?7V>rop5$N$_u!z7SP0SIS*h(fK3Q>Tt49> z#!$#C!qja(BGP9byz}Jv>|Cqagoj$K`%=bx^}6R;@33zrG^qI`fLIRU7nVor632Bh zqOSHo_2*Iu{RO|YVenZ@px8Bh0j1Dt@s$zUW8r>0g1cxfPY0w8qUN+19nQ{j@3xQ0XM zLSuL@M=m7vLi(V{u{+8Xv-VEQSpGl8-`~Y}I2_gnj7K#nY1*o3FB+^DU})H7V5VXv zFNQTyt!5yJgVg9b=2N(eC}z+`BgoM}lsUZt6SdYM1Du3%>~%6W%jOH(gAyrR44wH0 zwA#S6TiZ|dEsQE`w;C;k1)5m&)RGTiXGz*%_BjkPj4Se3gaZnS?=nRe2_+Q9D;NZ( zso{qE*)bJ&Pj1!9^dt-RVn#ifDg}`!pg<5fgxkUpUUsX#xO*OB0Lg?RE>H`KIg<=% z1FAV^iURBGPzZz93UWf2A>w733%vn49ENQ8fv%?th_a!6{?9M}lEm>3Z?x}af+{%7 z8|k0E{$ysR-#vZRJv-m`*l9xe=+RNT_iVr2IX!v=`u@-Rf*9tiR_u0lz*$rct{AqM zBV1s%>g&U9zgq=P!H};9tcVOxRGOWNy%R(*F0fYHy$-nVk_bfstuznd_=(lH`!z|e zF}5^j_`1^Ue$=dDxAK^BYP+?&yS-yI(vxgI4gxj-P1WgcoIvV$*Vg2fJK8N%cIZ@L zczgkS??+g=K9F%wl@N>u0%DQ^!Ek{P295Vb!r*8@JmCJKbpQxoW%MMhwrdz diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E deleted file mode 100644 index 067a5236..00000000 --- a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E +++ /dev/null @@ -1,23 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAEXZzOmNhdGFsb2dzZXJ2aWNlAAAAC0dBVk8gREMgVEFQAAAAHABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAVABBAFAAIABzAGUAcgB2AGkAYwBlAAAAAAAAFBkAVABoAGUAIABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACcAcwAgAFQAQQBQACAAZQBuAGQAIABwAG8AaQBuAHQALgAgACAACgBUAGgAZQAgAFQAYQBiAGwAZQAgAEEAYwBjAGUAcwBzACAAUAByAG8AdABvAGMAbwBsACAAKABUAEEAUAApACAAbABlAHQAcwAgAHkAbwB1ACAAZQB4AGUAYwB1AHQAZQAgAHEAdQBlAHIAaQBlAHMAIABhAGcAYQBpAG4AcwB0ACAAbwB1AHIACgBkAGEAdABhAGIAYQBzAGUAIAB0AGEAYgBsAGUAcwAsACAAaQBuAHMAcABlAGMAdAAgAHYAYQByAGkAbwB1AHMAIABtAGUAdABhAGQAYQB0AGEALAAgAGEAbgBkACAAdQBwAGwAbwBhAGQAIAB5AG8AdQByACAAbwB3AG4ACgBkAGEAdABhAC4AIAAgAAoACgBJAG4AIABHAEEAVgBPACcAcwAgAGQAYQB0AGEAIABjAGUAbgB0AGUAcgAsACAAdwBlACAAaQBuACAAcABhAHIAdABpAGMAdQBsAGEAcgAgAGgAbwBsAGQAIABzAGUAdgBlAHIAYQBsACAAbABhAHIAZwBlAAoAYwBhAHQAYQBsAG8AZwBzACAAbABpAGsAZQAgAFAAUABNAFgATAAsACAAMgBNAEEAUwBTACAAUABTAEMALAAgAFUAUwBOAE8ALQBCADIALAAgAFUAQwBBAEMANAAsACAAVwBJAFMARQAsACAAUwBEAFMAUwAgAEQAUgAxADYALAAKAEgAUwBPAFkALAAgAGEAbgBkACAAcwBlAHYAZQByAGEAbAAgAEcAYQBpAGEAIABkAGEAdABhACAAcgBlAGwAZQBhAHMAZQBzACAAYQBuAGQAIABhAG4AYwBpAGwAbABhAHIAeQAgAHIAZQBzAG8AdQByAGMAZQBzACAAZgBvAHIACgB5AG8AdQAgAHQAbwAgAHUAcwBlACAAaQBuACAAYwByAG8AcwBzAG0AYQB0AGMAaABlAHMALAAgAHAAbwBzAHMAaQBiAGwAeQAgAHcAaQB0AGgAIAB1AHAAbABvAGEAZABlAGQAIAB0AGEAYgBsAGUAcwAuAAoACgBUAGEAYgBsAGUAcwAgAGUAeABwAG8AcwBlAGQAIAB0AGgAcgBvAHUAZwBoACAAdABoAGkAcwAgAGUAbgBkAHAAbwBpAG4AdAAgAGkAbgBjAGwAdQBkAGUAOgAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAYQBtAGEAbgBkAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgBuAGkAcwByAGUAZAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAxADAAIABzAGMAaABlAG0AYQAsACAAZAByADEAMAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABvACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHAAcABsAGEAdQBzAGUAIABzAGMAaABlAG0AYQAsACAAZwBmAGgALAAgAGkAZAAsACAAaQBkAGUAbgB0AGkAZgBpAGUAZAAsACAAbQBhAHMAdABlAHIALAAgAG4AaQBkACwAIAB1AG4AaQBkAGUAbgB0AGkAZgBpAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcgBpAGcAZgBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBoAGkAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQB1AGcAZQByACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAaABvAHQAXwBhAGwAbAAsACAAcwBzAGEAXwB0AGkAbQBlAF8AcwBlAHIAaQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABiAGcAZABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABiAG8AeQBkAGUAbgBkAGUAIABzAGMAaABlAG0AYQAsACAAYwBhAHQAIABmAHIAbwBtACAAdABoAGUAIABiAHIAbwB3AG4AZAB3AGEAcgBmAHMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABmAGwAdQB4AHAAbwBzAHYAMQAyADAAMAAsACAAZgBsAHUAeABwAG8AcwB2ADUAMAAwACwAIABmAGwAdQB4AHYAMQAyADAAMAAsACAAZgBsAHUAeAB2ADUAMAAwACwAIABvAGIAagBlAGMAdABzACwAIABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAGwAaQBmAGEAZAByADMAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHMAcgBjAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwAgAHMAYwBoAGUAbQBhACwAIABtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwBhAHIAYwBzACAAcwBjAGgAZQBtAGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBzAGEAXwBsAGkAbgBlAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAdQBwAGQAYQB0AGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwA4ADIAbQBvAHIAcABoAG8AegAgAHMAYwBoAGUAbQBhACwAIABnAGUAbwAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwB0AGwAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAYQBuAGkAcwBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHAAbABhAHQAZQBzACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AF8AcwBwAGUAYwB0AHIAYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHMAcABlAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAbQB1AGIAaQBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABlAG0AaQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGYAawA2AGoAbwBpAG4ALAAgAHAAYQByAHQAMQAsACAAcABhAHIAdAAzACAAZgByAG8AbQAgAHQAaABlACAAZgBrADYAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAbABhAHIAZQBfAHMAdQByAHYAZQB5ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAG8AcgBkAGUAcgBzAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQBzAGgAaABlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAG8AcgBuAGEAeAAgAHMAYwBoAGUAbQBhACwAIABkAHIAMgBfAHQAcwBfAHMAcwBhACwAIABkAHIAMgBlAHAAbwBjAGgAZgBsAHUAeAAsACAAZAByADIAbABpAGcAaAB0ACwAIABkAHIAMwBsAGkAdABlACwAIABlAGQAcgAzAGwAaQB0AGUAIABmAHIAbwBtACAAdABoAGUAIABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGgAeQBhAGMAbwBiACwAIABtAGEAZwBsAGkAbQBzADUALAAgAG0AYQBnAGwAaQBtAHMANgAsACAAbQBhAGcAbABpAG0AcwA3ACwAIABtAGEAaQBuACwAIABtAGkAcwBzAGkAbgBnAF8AMQAwAG0AYQBzACwAIAByAGUAagBlAGMAdABlAGQALAAgAHIAZQBzAG8AbAB2AGUAZABzAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGMAbgBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABnAGMAcABtAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAYQBwACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGQAaQBzAHQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcABoAG8AdABvAG0AZQB0AHIAeQAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABzAHAAZQBjAHQAcgBhACwAIABzAHMAYQBtAGUAdABhACwAIAB3AGkAdABoAHAAbwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAYQB1AHQAbwAgAHMAYwBoAGUAbQBhACwAIABsAGkAdABlAHcAaQB0AGgAZABpAHMAdAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGcAZQBuAGUAcgBhAHQAZQBkAF8AZABhAHQAYQAsACAAbQBhAGcAbABpAG0AXwA1ACwAIABtAGEAZwBsAGkAbQBfADYALAAgAG0AYQBnAGwAaQBtAF8ANwAsACAAbQBhAGkAbgAsACAAcABhAHIAcwBlAGMAXwBwAHIAbwBwAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAHMAcAB1AHIAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAcwBlAHIAdgBpAGMAZQBzACwAIAB0AGEAYgBsAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAbABvAHQAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBwAHMAMQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABkAGcAYQBpAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBpAGMAbwB1AG4AdABlAHIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBwAHAAYQByAGMAbwBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHAAcAB1AG4AaQBvAG4AIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAcwBvAHkAIABzAGMAaABlAG0AYQAsACAAbgB1AGMAYQBuAGQAIABmAHIAbwBtACAAdABoAGUAIABpAGMAZQBjAHUAYgBlACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABpAG4AZgBsAGkAZwBoAHQAIABzAGMAaABlAG0AYQAsACAAbwBiAHMAXwByAGEAZABpAG8ALAAgAG8AYgBzAGMAbwByAGUAIABmAHIAbwBtACAAdABoAGUAIABpAHYAbwBhACAAcwBjAGgAZQBtAGEALAAgAGUAdgBlAG4AdABzACwAIABwAGgAbwB0AHAAbwBpAG4AdABzACwAIAB0AGkAbQBlAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAawAyAGMAOQB2AHMAdAAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAYQBwAHQAZQB5AG4AIABzAGMAaABlAG0AYQAsACAAawBhAHQAawBhAHQAIABmAHIAbwBtACAAdABoAGUAIABrAGEAdABrAGEAdAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANQAgAHMAYwBoAGUAbQBhACwAIABzAHMAYQBfAGwAcgBzACwAIABzAHMAYQBfAG0AcgBzACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANgAgAHMAYwBoAGUAbQBhACwAIABkAGkAcwBrAF8AYgBhAHMAaQBjACwAIABoAF8AbABpAG4AawAsACAAaQBkAGUAbgB0ACwAIABtAGUAcwBfAGIAaQBuAGEAcgB5ACwAIABtAGUAcwBfAG0AYQBzAHMAXwBwAGwALAAgAG0AZQBzAF8AbQBhAHMAcwBfAHMAdAAsACAAbQBlAHMAXwByAGEAZABpAHUAcwBfAHMAdAAsACAAbQBlAHMAXwBzAGUAcABfAGEAbgBnACwAIABtAGUAcwBfAHQAZQBmAGYAXwBzAHQALAAgAG8AYgBqAGUAYwB0ACwAIABwAGwAYQBuAGUAdABfAGIAYQBzAGkAYwAsACAAcAByAG8AdgBpAGQAZQByACwAIABzAG8AdQByAGMAZQAsACAAcwB0AGEAcgBfAGIAYQBzAGkAYwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQBmAGUAXwB0AGQAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AYwBvAHUAbgB0AHMALAAgAG0AZQBhAHMAdQByAGUAbQBlAG4AdABzACwAIABzAHQAYQB0AGkAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZwBoAHQAbQBlAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AGYAcgBhAG0AZQBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAHYAZQByAHAAbwBvAGwAIABzAGMAaABlAG0AYQAsACAAcgBtAHQAYQBiAGwAZQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAbwB0AHMAcwBwAG8AbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbABzAHAAbQAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAsACAAdwBvAGwAZgBwAGEAbABpAHMAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwB3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABtAGEAZwBpAGMAIABzAGMAaABlAG0AYQAsACAAcgBlAGQAdQBjAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYQBpAGQAYQBuAGEAawAgAHMAYwBoAGUAbQBhACwAIABlAHgAdABzACAAZgByAG8AbQAgAHQAaABlACAAbQBjAGUAeAB0AGkAbgBjAHQAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABzAGwAaQB0AHMAcABlAGMAdAByAGEAIABmAHIAbwBtACAAdABoAGUAIABtAGwAcQBzAG8AIABzAGMAaABlAG0AYQAsACAAZQBwAG4AXwBjAG8AcgBlACwAIABtAHAAYwBvAHIAYgAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcwB0AGEAcgBzACAAZgByAG8AbQAgAHQAaABlACAAbQB3AHMAYwBlADEANABhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABvAGIAcwBjAG8AZABlACAAcwBjAGgAZQBtAGEALAAgAGIAaQBiAHIAZQBmAHMALAAgAG0AYQBwAHMALAAgAG0AYQBzAGUAcgBzACwAIABtAG8AbgBpAHQAbwByACAAZgByAG8AbQAgAHQAaABlACAAbwBoAG0AYQBzAGUAcgAgAHMAYwBoAGUAbQBhACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABvAG4AZQBiAGkAZwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHMAaABhAHAAZQBzACAAZgByAG8AbQAgAHQAaABlACAAbwBwAGUAbgBuAGcAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcABjAGMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAbABjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAyACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAdABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAG8AbABjAGEAdABzAG0AYwAgAHMAYwBoAGUAbQBhACwAIABjAHUAYgBlAHMALAAgAG0AYQBwAHMAIABmAHIAbwBtACAAdABoAGUAIABwAHAAYQBrAG0AMwAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHUAcwBuAG8AYwBvAHIAcgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcABtAHgAbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAcAAxADAALAAgAG0AYQBwADYALAAgAG0AYQBwADcALAAgAG0AYQBwADgALAAgAG0AYQBwADkALAAgAG0AYQBwAF8AdQBuAGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcAByAGQAdQBzAHQAIABzAGMAaABlAG0AYQAsACAAZAByADIALAAgAGQAcgAzACwAIABkAHIANAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAYQB2AGUAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHAAaABvAHQAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIAByAG8AcwBhAHQAIABzAGMAaABlAG0AYQAsACAAYQBsAHQAXwBpAGQAZQBuAHQAaQBmAGkAZQByACwAIABhAHUAdABoAG8AcgBpAHQAaQBlAHMALAAgAGMAYQBwAGEAYgBpAGwAaQB0AHkALAAgAGcAXwBuAHUAbQBfAHMAdABhAHQALAAgAGkAbgB0AGUAcgBmAGEAYwBlACwAIABpAG4AdABmAF8AcABhAHIAYQBtACwAIAByAGUAZwBpAHMAdAByAGkAZQBzACwAIAByAGUAbABhAHQAaQBvAG4AcwBoAGkAcAAsACAAcgBlAHMAXwBkAGEAdABlACwAIAByAGUAcwBfAGQAZQB0AGEAaQBsACwAIAByAGUAcwBfAHIAbwBsAGUALAAgAHIAZQBzAF8AcwBjAGgAZQBtAGEALAAgAHIAZQBzAF8AcwB1AGIAagBlAGMAdAAsACAAcgBlAHMAXwB0AGEAYgBsAGUALAAgAHIAZQBzAG8AdQByAGMAZQAsACAAcwB0AGMAXwBzAHAAYQB0AGkAYQBsACwAIABzAHQAYwBfAHMAcABlAGMAdAByAGEAbAAsACAAcwB0AGMAXwB0AGUAbQBwAG8AcgBhAGwALAAgAHMAdQBiAGoAZQBjAHQAXwB1AGEAdAAsACAAdABhAGIAbABlAF8AYwBvAGwAdQBtAG4ALAAgAHQAYQBwAF8AdABhAGIAbABlACwAIAB2AGEAbABpAGQAYQB0AGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcgByACAAcwBjAGgAZQBtAGEALAAgAG8AYgBqAGUAYwB0AHMALAAgAHAAaABvAHQAcABhAHIAIABmAHIAbwBtACAAdABoAGUAIABzAGEAcwBtAGkAcgBhAGwAYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIAMQA2ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAGQAcwBzAGQAcgA3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAG0AYQBrAGMAZQBkACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAZQBjAGkAZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAbQA0ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAHUAcABlAHIAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAZwByAG8AdQBwAHMALAAgAGsAZQB5AF8AYwBvAGwAdQBtAG4AcwAsACAAawBlAHkAcwAsACAAcwBjAGgAZQBtAGEAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcABfAHMAYwBoAGUAbQBhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcAB0AGUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGUAbgBwAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAZwBhAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAaABlAG8AcwBzAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAbABpAG4AZQBfAHQAYQBwACAAZgByAG8AbQAgAHQAaABlACAAdABvAHMAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdAB3AG8AbQBhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABpAGMAcgBzAGMAbwByAHIALAAgAG0AYQBpAG4ALAAgAHAAcABtAHgAbABjAHIAbwBzAHMAIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AHIAYQB0ADEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAcABsAGEAdABlAGMAbwByAHIAcwAsACAAcABsAGEAdABlAHMALAAgAHAAcABtAHgAYwByAG8AcwBzACwAIABzAHAAdQByAGkAbwB1AHMALAAgAHQAdwBvAG0AYQBzAHMAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBzAG4AbwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB2AGUAcgBvAG4AcQBzAG8AcwAgAHMAYwBoAGUAbQBhACwAIABzAHQAcgBpAHAAZQA4ADIAIABmAHIAbwBtACAAdABoAGUAIAB2AGwAYQBzAHQAcgBpAHAAZQA4ADIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAZABzAGQAcwBzADEAMAAgAHMAYwBoAGUAbQBhACwAIABhAHIAYwBoAGkAdgBlAHMALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGYAcABkAGIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAaQBzAGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHgAcABwAGEAcgBhAG0AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAegBjAG8AcwBtAG8AcwAgAHMAYwBoAGUAbQBhAC4AAAA3aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDA5LTEyLTAxVDEwOjAwOjAwAAAAEzIwMjQtMDItMDZUMTA6MTk6MzMAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAFYaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vZXhhbXBsZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi90YWJsZU1ldGFkYXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXAAAADYaXZvOi8vaXZvYS5uZXQvc3RkL2RhbGkjZXhhbXBsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSN0YWJsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNjYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNhdmFpbGFiaWxpdHk6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwAAAAeXZyOndlYmJyb3dzZXI6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHAAAABIOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkAAAAPDo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Og==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta b/pyvo/discover/tests/data/access-url-elision/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta deleted file mode 100644 index f4dc32860a4ba98138dccb0ade9e7a3d307219e8..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2916 zcmds3NpIUm6gC<=cH=aT8?->t1W*qS>@cEiIZGWN2UV7{DUu`0NpmO$L-I*vOp(mY zP_haHXf8z!@K*Ns^x7ZMAJcD0N^)|@;$sB?ocHE!^Y-87|9ZJRm;K(P>&dcIT*Z>v zp+o7Df09L)xI;pw$rVAbW0FdmQi<4Bu^^4Db4iZ^NrCi~H>6$9R_UMV#@qBwnw)1+ zg@V##*$#c5Y~_Ukc$V7&BFUN1cA$4v2_DEEi82My?FIcbS?x}6jVW%?cH`iPob-2y zmn4QHa5yLq*LHdR;X$Qp?wHk*8hKKY^Mb5Ob<^B7H#N_^!xapg-_1VPo`%8AQuR)0 zkE~L4vwEwvxpQyp_Ptx%r3X*Dn*O3428sezR^teK7wZMs&A{(?6#1Ub^}{O1a8GXyTRqYWk?T?{1 zsBD{CTZq7V(+lF`4eiGjZrc>8Q_)?i<(OG)SNp$u(an-WJs;7zS+a!YJfCyokTc*l zH!3&u%>~3J$g>InA~OSyh@vw0k&v43(j0L_B? z(B}Ji*-7&CyY~@Cl(ZfN=?nl}tRXRTT{&;*%o4f-tIP$(AgK?Y?vp7JxGNI>S(ko*as zL(&#rq?<>MLi{Q$i$8KkSrc#XS~xe@KSVffriX@zrR-fvEHsV8wd3Uj=C}> z5+FBst$H{6?`U26v|Y>p(b#z2HY7z;OipLi4vd+I>mGBt~MVRN#*%fLDpQaFfgT0rIXHxr~9Eo`Db=pty5dt$W&p<$}TKBM1 zYZ}eQUe{2ODdB~Ot)SPJiR-HLE4J- z<**{q2y%M8x=9Pv-S#0NLsFCQZJaZ8*tX z>c(!Y(zlo&>~(GsQ{I3=AX}5Ufo|w{0(*r7ZjohUZ>)!^?t{b!I4&@ogl1XNv*}pR X`D|xOR+x=_7#+J - -http://dc.zah.uni-heidelberg.de/taphttps://dc.zah.uni-heidelberg.de/tapGloTS 1.0Registry 1.1Obscore-1.1ADQL2.02.1The Astronomical Data Query Language is the standard IVOA dialect of SQL; it contains a very general SELECT statement as well as some extensions for spherical geometry and higher mathematics.
gavo_apply_pm(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmde DOUBLE PRECISION, epdist DOUBLE PRECISION) -> POINT
Returns a POINT (in the UNDEFINED reference frame) for the position -an object at ra/dec with proper motion pmra/pmde has after epdist years. - -positions must be in degrees, PMs in should be in julian years (i.e., proper -motions are expected in degrees/year). pmra is assumed to contain -cos(delta). - -This function goes through the tangential plane. Since it does not have -information on distance and radial velocity, it cannot reconstruct -the true space motion, and hence its results will degrade over time. - -This function should not be used in new queries; use ivo_epoch_prop -instead.
gavo_getauthority(ivoid TEXT) -> TEXT
returns the authority part of an ivoid (or, more generally a URI). -So, ivo://org.gavo.dc/foo/bar#baz becomes org.gavo.dc. - -The behaviour for anything that's not a full URI is undefined.
gavo_ipix(long REAL, lat REAL) -> BIGINT
gavo_ipix returns the q3c ipix for a long/lat pair (it simply wraps -the 13c_ang2ipix function). - -This is probably only relevant when you play tricks with indices or -PPMXL ids.
gavo_match(pattern TEXT, string TEXT) -> INTEGER
gavo_match returns 1 if the POSIX regular expression pattern -matches anything in string, 0 otherwise.
gavo_mocintersect(moc1 MOC, moc2 MOC) -> MOC
returns the intersection of two MOCs.
gavo_mocunion(moc1 MOC, moc2 MOC) -> MOC
returns the union of two MOCs.
gavo_specconv(expr DOUBLE PRECISION, dest_unit TEXT) -> DOUBLE PRECISION
returns the spectral value expr converted to dest_unit. - -expr has to be in either energy, wavelength, or frequency, and dest_unit -must be a VOUnit giving another spectral unit (e.g., MHz, keV, nm, or -Angstrom). This is intended to let users express spectral constraints -in their preferred unit independently of the choice of unit in the -database. Examples:: - - gavo_specconv(obscore.em_min, "keV") > 300 - gavo_specconv(obscore.em_max, "MHz") > 30 - gavo_specconv(spectral_start, "Angstrom") > 4000 - -There is a variant of gavo_specconv accepting expr's unit in a third -argument.
gavo_specconv(expr NUMERIC, expr_unit TEXT, dest_unit TEXT) -> NUMERIC
returns expr assumed to be in expr_unit expressed in dest_unit. - - This is a variant of the two-argument gavo_specconv for when - the unit of expr is not known to the ADQL translator, either because - it because it is a literal or because it does not look like - a spectral unit. Examples:: - - gavo_specconv(656, 'nm', 'J') BETWEEN spectral_start AND spectral_end - gavo_specconv(arccos(phi)*incidence, 'Hz', 'eV') - - Clearly, overriding known units is likely to yield bad results; - the translator therefore warns if an existing unit is overridden - with a different unit.
gavo_vocmatch(vocname TEXT, term TEXT, matchagainst TEXT) -> INTEGER
returns 1 if matchagainst is term or narrower in the IVOA vocabulary -vocname, 0 otherwise. - -This is intended for semantic querying. For instance, -gavo_vocmatch('datalink/core', 'calibration', semantics) would be 1 -if semantics is any of calibration, bias, dark, or flat. - -For RDF-flavoured vocabularies (strict trees), term will expand to the -entire branch rooted in term. For SKOS-flavoured vocabularies (where -narrower is not transitive), only directly narrower terms will be included. - -Both the term and the vocabulary name must be string literals (i.e., -constants). matchagainst can be any string-valued expression.
ivo_epoch_prop(ra DOUBLE PRECISION, dec DOUBLE PRECISION, parallax DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, radial_velocity DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> DOUBLE PRECISION[6]
Returns a 6-vector of (ra, dec, parallax, pmra, pmdec, rv) -at out_epoch for these quantities at ref_epoch. - -Essentially, it will apply the proper motion under the assumption of -linear motion. Despite the name of the positional parameters, this is -not restricted to equatorial systems, as long as positions and proper -motions are expressed in the same reference frames. - -Units on input and output are degrees for ra and dec, mas for parallax, -mas/yr for pmra and pmdec, and km/s for the radial velocity. - -ref_epoch and out_epoch are given in Julian years. - -parallax, pmra, pmdec, and radial_velocity may be None and will enter -the computations as 0 then, except in the case of parallax, which -will be some small value. When abs(parallax) is smaller or equal -to that small value, parallax and radial velocity will be NULL on -output. - -In daily use, you probably want to use the ivo_epoch_prop_pos functions.
ivo_epoch_prop_pos(ra DOUBLE PRECISION, dec DOUBLE PRECISION, parallax DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, radial_velocity DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> POINT
Returns a POINT giving the position at out_epoch for an object -with the six parameters at ref_epoch. - -Essentially, it will apply the proper motion under the assumption of -linear motion. Despite the name of the positional parameters, this is -not restricted to equatorial systems, as long as positions and proper -motions are expressed in the same reference frames. - -Units on input are degrees for ra and dec, mas for parallax, -mas/yr for pmra and pmdec, and km/s for the radial velocity. -ref_epoch and out_epoch are given in Julian years. - -parallax, pmra, pmdec, and radial_velocity may be None and will enter -the computations as 0 then, except in the case of parallax, which -will be some small value.
ivo_epoch_prop_pos(ra DOUBLE PRECISION, dec DOUBLE PRECISION, pmra DOUBLE PRECISION, pmdec DOUBLE PRECISION, ref_epoch DOUBLE PRECISION, out_epoch DOUBLE PRECISION) -> POINT
A variant of ivo_epoch_prop_pos that behave as if parallax - and radial_velocity were both passed as NULL.
ivo_geom_transform(from_sys TEXT, to_sys TEXT, geo GEOMETRY) -> GEOMETRY
The function transforms ADQL geometries between various reference systems. -geo can be a POINT, a CIRCLE, or a POLYGON, and the function will return a -geometry of the same type. In the current implementation, from_sys and -to_sys must be literal strings (i.e., they cannot be computed through -expressions or be taken from database columns). - -All transforms are just simple rotations, which is only a rough -approximation to the actual relationships between reference systems -(in particular between FK4 and ICRS-based ones). Note that, in particular, -the epoch is not changed (i.e., no proper motions are applied). - -We currently support the following reference frames: ICRS, FK5 (which -is treated as ICRS), FK4 (for B1950. without epoch-dependent corrections), -GALACTIC. Reference frame names are case-sensitive.
ivo_hashlist_has(hashlist TEXT, item TEXT) -> INTEGER
The function takes two strings; the first is a list of words not -containing the hash sign (#), concatenated by hash signs, the second is -a word not containing the hash sign. It returns 1 if, compared -case-insensitively, the second argument is in the list of words coded in -the first argument. The behaviour in case the the second -argument contains a hash sign is unspecified.
ivo_hasword(haystack TEXT, needle TEXT) -> INTEGER
gavo_hasword returns 1 if needle shows up in haystack, 0 otherwise. This -is for "google-like"-searches in text-like fields. In word, you can -actually employ a fairly complex query language; see -https://www.postgresql.org/docs/current/textsearch.html -for details.
ivo_healpix_center(hpxOrder INTEGER, hpxIndex BIGINT) -> POINT
returns a POINT corresponding to the center of the healpix with -the given index at the given order.
ivo_healpix_index(order INTEGER, ra DOUBLE PRECISION, dec DOUBLE PRECISION) -> BIGINT
Returns the index of the (nest) healpix with order containing the -spherical point (ra, dec). - -An alternative, 2-argument form - -ivo_healpix_index(order INTEGER, p POINT) -> BIGINT - -is also available.
ivo_histogram(val REAL, lower REAL, upper REAL, nbins INTEGER) -> INTEGER[]
The aggregate function returns a histogram of val with nbins+2 elements. -Assuming 0-based arrays, result[0] contains the number of underflows (i.e., -val<lower), result[nbins+1] the number of overflows. Elements 1..nbins -are the counts in nbins bins of width (upper-lower)/nbins. Clients -will have to convert back to physical units using some external -communication, there currently is no (meta-) data as lower and upper in -the TAP response.
ivo_interval_has(val NUMERIC, iv INTERVAL) -> INTEGER
The function returns 1 if the interval iv contains val, 0 otherwise. -The lower limit is always included in iv, behaviour on the upper -limit is column-specific.
ivo_interval_overlaps(l1 NUMERIC, h1 NUMERIC, l2 NUMERIC, h2 NUMERIC) -> INTEGER
The function returns 1 if the interval [l1...h1] overlaps with -the interval [l2...h2]. For the purposes of this function, -the case l1=h2 or l2=h1 is treated as overlap. The function -returns 0 for non-overlapping intervals.
ivo_nocasematch(value TEXT, pattern TEXT) -> INTEGER
ivo_nocasematch returns 1 if pattern matches value, 0 otherwise. -pattern is defined as for the SQL LIKE operator, but the -match is performed case-insensitively. This function in effect -provides a surrogate for the ILIKE SQL operator that is missing from -ADQL. - -On this site, this is actually implemented using python's and SQL's -LOWER, so for everything except ASCII, your mileage will vary.
ivo_normal_random(mu REAL, sigma REAL) -> REAL
The function returns a random number drawn from a normal distribution -with mean mu and width sigma. - -Implementation note: Right now, the Gaussian is approximated by -summing up and scaling ten calls to random. This, hence, is not -very precise or fast. It might work for some use cases, and we -will provide a better implementation if this proves inadequate.
ivo_simbadpoint(identifier TEXT) -> POINT
gavo_simbadpoint queries simbad for an identifier and returns the -corresponding point. Note that identifier can only be a literal, -i.e., as simple string rather than a column name. This is because -our database cannot query simbad, and we probably wouldn't want -to fire off millions of simbad queries anyway; use simbad's own -TAP service for this kind of application.
ivo_string_agg(expression TEXT, delimiter TEXT) -> TEXT
An aggregate function returning all values of -expression within a GROUP contcatenated with delimiter
ivo_to_jd(d TIMESTAMP) -> DOUBLE PRECISION
The function converts a postgres timestamp to julian date. -This is naive; no corrections for timezones, let alone time -scales or the like are done; you can thus not expect this to be -good to second-precision unless you are careful in the construction -of the timestamp.
ivo_to_mjd(d TIMESTAMP) -> DOUBLE PRECISION
The function converts a postgres timestamp to modified julian date. -This is naive; no corrections for timezones, let alone time -scales or the like are done; you can thus not expect this to be -good to second-precision unless you are careful in the construction -of the timestamp.
BOX
POINT
CIRCLE
POLYGON
REGION
CENTROID
COORD1
COORD2
DISTANCE
CONTAINS
INTERSECTS
AREA
LOWER
ILIKE
OFFSET
CAST
IN_UNIT
WITH
TABLESAMPLE
Written after a table reference, TABLESAMPLE(10) will make the database only use 10% of the rows; these are `somewhat random' in that the system will use random blocks. This should be good enough when just testing queries (and much better than using TOP n).
MOC
A geometry function creating MOCs. It either takes a string argument with an ASCII MOC ('4/13 17-18 8/3002'), or an order and another geometry.
COALESCE
This is the standard SQL COALESCE for providing defaults in case of NULL values.
VECTORMATH
You can compute with vectors here. See https://wiki.ivoa.net/twiki/bin/view/IVOA/ADQLVectorMath for an overview of the functions and operators available.
CASE
The SQL92 CASE expression
UNION
EXCEPT
INTERSECT
text/tab-separated-valuestsvtext/plaintxttext/csvcsv_baretext/csv;header=presentcsvapplication/jsonjsonapplication/geo+jsongeojsonapplication/x-votable+xmlvotableapplication/x-votable+xml;serialization=BINARY2votable/b2votableb2application/x-votable+xml;serialization=TABLEDATAtext/xmlvotable/tdvotabletdapplication/x-votable+xml;serialization=TABLEDATA;version=1.1text/xmlvotabletd1.1application/x-votable+xml;version=1.1text/xmlvotable1.1application/x-votable+xml;serialization=TABLEDATA;version=1.2text/xmlvotabletd1.2application/x-votable+xml;serialization=TABLEDATA;version=1.5vodmlapplication/x-votable+xml;version=1.5vodmlbtext/htmlhtmlapplication/fitsfits17280072002000016000000100000000
http://dc.zah.uni-heidelberg.de/__system__/tap/run/availabilityhttps://dc.zah.uni-heidelberg.de/__system__/tap/run/availabilityhttp://dc.zah.uni-heidelberg.de/__system__/tap/run/capabilitieshttps://dc.zah.uni-heidelberg.de/__system__/tap/run/capabilitieshttp://dc.zah.uni-heidelberg.de/__system__/tap/run/tableMetadatahttps://dc.zah.uni-heidelberg.de/__system__/tap/run/tableMetadatahttp://dc.zah.uni-heidelberg.de/__system__/tap/run/exampleshttps://dc.zah.uni-heidelberg.de/__system__/tap/run/examples
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-capabilities-VYcr5usI.meta deleted file mode 100644 index 7662b211e10087fdc77d564756dd61b02dc6f7e0..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1504 zcmZWpO>Y}F5H%Xv7A!ZCVrs;PD~RoHSYCk~ zg2ct!V)3|5PriNY2i~C<)b)rd4e=#}e$e#xy{5}4#Z=>kO6}?A@f*SS>cK(%8wl$` zGk8{S9vW#jmc>%rGlv8XPArh~7ZoYJ9q z;*vKb!8Il}^d!SWH%|)lVrrH(jI}==q!^m3(5x2#Tk~)ZH5rKL%3Jui$@z?fv+zBl z*_C2EnS;G!%488(ofq&1$YY9_SGy82il7%2mT7AP(20nxxp(^V0{?TFTJuGsb#~8 zGr#2>crgrLw7%?z;j^Fz)QcVN%>YU0PVge!-}hQAq;KbY#`E#6!?8-E2r_-EHLAxm z&$2PL`oFMjuO34$MV9vJp>&yRvrJsf67YRb{ikkc1G(X|mP7-YSsGUWS%aq7%>^@M zl!Lf(FE+IWvJ2N%0jWBf2EC$k3GO<{M9QLxHTNB&-Yn@ohM4U(^k|;ySyp!zRwxI_ zS4SDT=*bF`qA;3N&FH+kvKdTAJd^Zp?$b`x(^@NCfnu^gaU&oXP7bE-XuOI(~JWSfx zHudT3+5sdU}<92D|~B=4A#djN*r)(H--|4YTJ*d$9bZ9n2`$%om+h-L#2 zxyECQSE7VtCb2CQ`qs&mq={<*oTNBi2Dn@$5lEL(c1Vt=I&|VQRTAMWCW}#QZ}Kqr F{sZQyP4EB! diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe deleted file mode 100644 index 328bc1b8..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe +++ /dev/null @@ -1,1814 +0,0 @@ - - -amandaAMANDA-II neutrino candidatesA list of neutrino candidate events recorded by the AMANDA-II neutrino -telescope during the period 2000-2006.amanda.nucand Detection parameters of neutrino candidates recorded by the AMANDA-II -telescope. This table can be queried on the web at -http://dc.g-vo.org/amanda/q/web6595idArtifical primary key.meta.id;meta.maincharindexedprimaryraj2000Neutrino arrival direction, RAdegpos.eq.ra;meta.mainfloatindexeddej2000Neutrino arrival direction, Declinationdegpos.eq.dec;meta.mainfloatindexednchNumber of optical modules hit in an eventmeta.numbershortang_errorAngular resolution of a neutrino eventdegpos.angResolutionfloatmjdObservation time, Modified Julian Daydtime.epoch;obsfloatatmonusubsetSubset of candidates used in AMANDA's seven-year atmospheric neutrino analysismeta.codebooleanorigin_estA circle around the most likely position with ang_error radius (for convenient matching).pos.outline;obs.fielddoublenullable
annisredStripe 82 Photometric Redshifts from SDSS Coadditions This survey gives photometric redshifts of objects within 275 deg² -(−50◦ < α < 60◦ and −1.◦25 < δ < +1.◦25) centered on the Celestial -Equator. Each piece of sky has ∼20 runs of repeated scanning by the -SDSS camera contributing and thus reaches ∼2 mag fainter than the SDSS -single pass data, i.e., to r ∼ 23.5 for galaxies.annisred.main This survey gives photometric redshifts of objects within 275 deg² -(−50◦ < α < 60◦ and −1.◦25 < δ < +1.◦25) centered on the Celestial -Equator. Each piece of sky has ∼20 runs of repeated scanning by the -SDSS camera contributing and thus reaches ∼2 mag fainter than the SDSS -single pass data, i.e., to r ∼ 23.5 for galaxies.14000000objidUnique SDSS identifier.meta.id;meta.mainlongindexedrunRun numbermeta.id;obsshortrerunRerun numbermeta.id;obsshortcamcolCamera columnmeta.id;instrshortfieldidField numbermeta.id;obs.fieldlongobjThe object id within a field. Usually changes between reruns of the same field.meta.idshortraj2000Right ascension of the object.degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of the object.degpos.eq.dec;meta.maindoubleindexednullablezphotPhotometric redshift from SDSS' PHOTO pipelinefloatindexednullablezphoterrError in the photometric redshift from SDSS' PHOTO pipelinefloatnullable
antares2007-2012 ANTARES search for cosmic neutrino point sources A time integrated search for point sources of cosmic neutrinos was -performed using the data collected from January 2007 to November 2012 -by the ANTARES neutrino telescope. This dataset includes a total of -5921 events obtained during the effective livetime of 1338 days.antares.data A time integrated search for point sources of cosmic neutrinos was -performed using the data collected from January 2007 to November 2012 -by the ANTARES neutrino telescope. This dataset includes a total of -5921 events obtained during the effective livetime of 1338 days.5921idIdentifier for this neutrino.meta.id;meta.maincharindexedprimaryraj2000Right Ascension, ICRSdegpos.eq.ra;meta.mainfloatnullabledej2000Declination, ICRSdegpos.eq.dec;meta.mainfloatnullablen_hitsNumber of signals from the photo multiplier tubes contributing to this observation.meta.number;obsshortang_error1 sigma confidence radius of the position.degstat.error;posfloatindexednullableepoch_mjdArrival time in UTC TOPOCENTER.dtime.epochdoublenullableorigin_estA circle around the most likely position with ang_error radius (for convenient matching).pos.outline;obs.fielddoubleindexednullable
antares102007-2010 ANTARES search for cosmic neutrino point sources A time integrated search for point sources of cosmic neutrinos was -performed using the data collected from January 2007 to November 2010 -by the ANTARES neutrino telescope. This dataset includes a total of -3058 events obtained during the effective livetime of 813 days. - -This is legacy data. The most recently released data can be found at -ivo://org.gavo.dc/antares/q/cone.antares10.data A time integrated search for point sources of cosmic neutrinos was -performed using the data collected from January 2007 to November 2010 -by the ANTARES neutrino telescope. This dataset includes a total of -3058 events obtained during the effective livetime of 813 days. - -This is legacy data. The most recently released data can be found at -ivo://org.gavo.dc/antares/q/cone.3092idIdentifier for this neutrino.meta.id;meta.maincharindexedprimaryraj2000Right Ascension, ICRSdegpos.eq.ra;meta.mainfloatnullabledej2000Declination, ICRSdegpos.eq.dec;meta.mainfloatnullablen_hitsNumber of signals from the photo multiplier tubes contributing to this observation.meta.number;obsshortang_error1 sigma confidence radius of the position.degstat.error;posfloatindexednullableorigin_estA circle around the most likely position with ang_error radius (for convenient matching).meta.id;obs.fielddoublenullable
apassAAVSO Photometric All Sky Survey (APASS) DR10 -AAVSO Photometric All-Sky Survey (APASS), underway since 2010, -covers the entire sky from 7.5 < V < 16.5 magnitude, and in the BVugrizY -bandpasses. A northern and a southern site are used, each with twin ASA -20cm astrographs and Apogee Aspen CG16m cameras, covering 2.9x2.9 square -degrees with 2.6arcsec pixels. Landolt and SDSS standards are used for -all-sky solutions, with typical 0.02mag calibration errors on the bright -end. - -Data Release 10 is a complete reprocessing of all 500K images taken with -the system, including hundreds of nights not part of DR9. Sextractor is -used for star finding and centroiding; DAOPHOT is used for aperture -photometry; the astrometry.net plate-solving library is used for basic -astrometry, supplanted with more precise WCS that utilizes knowledge of the -optical train distortions. With these changes, DR10 includes many more -stars than prior releases. - -More information is available at http://www.aavso.org/apass.apass.dr10 -AAVSO Photometric All-Sky Survey (APASS), underway since 2010, -covers the entire sky from 7.5 < V < 16.5 magnitude, and in the BVugrizY -bandpasses. A northern and a southern site are used, each with twin ASA -20cm astrographs and Apogee Aspen CG16m cameras, covering 2.9x2.9 square -degrees with 2.6arcsec pixels. Landolt and SDSS standards are used for -all-sky solutions, with typical 0.02mag calibration errors on the bright -end. - -Data Release 10 is a complete reprocessing of all 500K images taken with -the system, including hundreds of nights not part of DR9. Sextractor is -used for star finding and centroiding; DAOPHOT is used for aperture -photometry; the astrometry.net plate-solving library is used for basic -astrometry, supplanted with more precise WCS that utilizes knowledge of the -optical train distortions. With these changes, DR10 includes many more -stars than prior releases. - -More information is available at http://www.aavso.org/apass.130000000idAPASS DR10 identifier formed as (SPD zone)-(star number)meta.id;meta.maincharindexedprimaryraICRS right ascension for this object.pos.eq.ra;meta.maindoubleindexednullabledecICRS declination for this object.pos.eq.dec;meta.maindoubleindexednullablera_errorEstimated error in ra (there will be additional systematics especially in crowded fields).degstat.error;pos.eq.rafloatnullabledec_errorEstimated error in dec (there will be additional systematics especially in crowded fields).degstat.error;pos.eq.decfloatnullablenobs_bNumber of observations that went into mag_bmeta.number;obs;em.opt.Bshortmag_bMagnitude in Johnson B (Vega system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Bfloatnullableerr_mag_bEstimated error in mag_b. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Bfloatnullablenobs_vNumber of observations that went into mag_vmeta.number;obs;em.opt.Vshortmag_vMagnitude in Johnson V (Vega system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Vfloatnullableerr_mag_vEstimated error in mag_v. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Vfloatnullablenobs_uNumber of observations that went into mag_umeta.number;obs;em.opt.Ushortmag_uMagnitude in Sloan u' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ufloatnullableerr_mag_uEstimated error in mag_u. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ufloatnullablenobs_gNumber of observations that went into mag_gmeta.number;obs;em.opt.Vshortmag_gMagnitude in Sloan g' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Vfloatnullableerr_mag_gEstimated error in mag_g. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Vfloatnullablenobs_rNumber of observations that went into mag_rmeta.number;obs;em.opt.Rshortmag_rMagnitude in Sloan r' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Rfloatnullableerr_mag_rEstimated error in mag_r. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Rfloatnullablenobs_iNumber of observations that went into mag_imeta.number;obs;em.opt.Ishortmag_iMagnitude in Sloan i' (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ifloatnullableerr_mag_iEstimated error in mag_i. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ifloatnullablenobs_z_sNumber of observations that went into mag_z_smeta.number;obs;em.opt.Ishortmag_z_sMagnitude in Sloan z_s (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ifloatnullableerr_mag_z_sEstimated error in mag_z_s. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ifloatnullablenobs_yNumber of observations that went into mag_ymeta.number;obs;em.opt.Ishortmag_yMagnitude in Sloan Y (AB system). This is an aperture magnitude obtained with DAOPHOT.magphot.mag;em.opt.Ifloatnullableerr_mag_yEstimated error in mag_y. From a comparison with DR9, it appears these estimates are overly pessimistic.magstat.error;phot.mag;em.opt.Ifloatnullable
apoApache Point observations of lensed quasarsObservations of the lensed quasar Q2237+0305 performed between 1995 -and 1998.apo.framesObservations of the lensed quasar Q2237+0305 performed between 1995 -and 1998.527accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullabletypecharnullableobjectcharnullableraw_objectcharnullablefilter1Filters on filter wheel 1charnullablefilter2Filters on filter wheel 2charnullableexposurefloatnullablealpharawRA of center of view 1950.0charnullabledeltarawDec of center of view 1950.0charnullablepub_didPublisher DID for this dataset.charnullable
applauseAPPLAUSE DR3 Plate Scans APPLAUSE DR3 contains images and metadata from 24 plate collections -in Hamburg, Bamberg, Potsdam, Tautenburg and Tartu, a total of 101138 -scans of 70276 photographic plates. The present table contains -metadata records for singly exposed plates with astrometric solutions -in APPLAUSE (about 44000). It is mainly intended as a basis for -publishing suitable APPLAUSE plates in the Obscore schema through the -TAP service in GAVO's Heidelberg Data Center. - -A TAP service with more complete metadata and, in particular, -extracted sources, is available at https://www.plate-archive.org/tap.applause.mainA redux of the calibrated subset of APPLAUSE to the obscore schema, -with constant columns removed.44370obs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharindexednullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoubleindexednullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoubleindexednullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoubleindexednullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoubleindexednullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullablepreviewURL for a preview of the imagemeta.ref.url;meta.previewcharnullableemulsionEmulsion of the original plate (from observatory log).instr.plate.emulsioncharnullablefilterFilter used (from observatory log).meta.id;instr.filter;meta.maincharnullable
arigfhARIGFH object catalogARI's "Geschichte des Fixsternhimmels" is an attempt to collect all -astrometrically useful observations from before ca. 1970 in a way -comparable to what has been done to construct the FK* series of -fundamental catalogs. About 7e6 published positions are included. - -In GAVO's DC, we provide tables of identified and non-identified stars -together with the master catalog that objects were identified against.arigfh.gfhThe table of (almost) all objects read from the catalogs, together -with most of the data given in them.7100000catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharindexednullablecatanObject number in source catalog, ARI assignedmeta.idintindexedcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoubleindexednullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoubleindexednullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.id The stars from the gfh table having counterparts in the master -catalog, together with those counterparts.masternoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintcompmasterComponent designation in a multiple system in the master catalogmeta.code.multipcharnullableraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoublenullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoublenullablepmramasterMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdemasterMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvmasterVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembmasterBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecatidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintdistOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.identifiedMatches between the master catalog and the historical catalogs.6300000distOffset between master catalog position at catalog epoch and equinox and the catalog positiondegpos.angDistancedoublenullablemasternoCatalog number in master catalog (arigfh.master)meta.id;meta.mainintindexeddcompComponent designation for multiple system, as in the master catalogmeta.code.multipcharnullableiqQuality of match, quality decreasing with values increasing from 2meta.code.qualshortcsortCatalog typemeta.codeshortcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexedcatanObject number in source catalog, ARI assignedmeta.idintindexed
arigfh.masterThe master catalog against which all ARIGFH historical observations -were matched.612627catnoIdentification number in the ARIGFH master catalogmeta.id;meta.mainintindexedprimaryraj2000Master Right Ascension, Epoch and Equinox J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Master Declination, Epoch and Equinox J2000degpos.eq.dec;meta.maindoubleindexednullablepmraMaster Proper Motion in RA, Epoch and Equinox J2000, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdeMaster Proper motion in Declination, Epoch and Equinox J2000deg/yrpos.pm;pos.eq.decdoublenullablemvVisual magnitude in the master catalogmagphot.mag;em.opt.VfloatnullablembBlue magnitude in the master catalogmagphot.mag;em.opt.BfloatnullablecomponentComponent designation in a multiple system in the master catalogmeta.code.multipcharnullable
arigfh.nid The stars from the gfh table that could not be matched with objects -in the master catalog.catidCatalog identifier as t(teleki no)p(part)(version)meta.refcharnullablecatanObject number in source catalog, ARI assignedmeta.idintcatcnObject number in source catalog, as in sourcemeta.idintcatcaSuffix to the designation in the source catalogmeta.idcharnullabledscodeCode for multiple star component designationmeta.code.multipshortmagApparent magnitude as specified by magsysphot.magfloatnullablemagsysSystem of magmeta.code;phot.magcharnullablevarflagCode for photometric variabilitymeta.code;src.varshortracatRight ascension at catalog equinox and epochdegpos.eq.radoublenullableeqraEquinox of the catalog RA, Julian yearsyrtime.equinox;pos.eq.rafloatnullableepraEpoch of the catalog RA, Julian yearsyrtime.epoch;pos.eq.rafloatnullablemeanepraMean Epoch of RA, Julian yearsyrtime.epochfloatnullablee_raMean error in right ascension as given in catalogdegstat.error;pos.eq.ra;meta.mainfloatnullablenobraNumber of observations combined into raCatmeta.number;obsfloatnullableusera0=RA unusable, 1=RA usable, 2=RA good, but epoch guessedmeta.code;pos.eq.rashortnullableraflagsDetails on observation and processing of RA (see note)meta.code;pos.eq.raintdeccatDeclination at catalog equinox and epochdegpos.eq.decdoublenullableeqdecEquinox of the catalog declination, Julian yearsyrtime.equinox;pos.eq.decfloatnullableepdecEpoch of the catalog declination, Julian yearsyrtime.epoch;pos.eq.decfloatnullablemeanepdecMean Epoch of the declination, Julian yearsyrtime.epochfloatnullablee_decMean error in declination as given in catalogdegstat.error;pos.eq.dec;meta.mainfloatnullablenobdecNumber of observations combined into decCatmeta.number;obsfloatnullableusedec0=Dec unusable, 1=Dec usable, 2=Dec good, but epoch guessedmeta.code;pos.eq.decshortnullabledecflagsDetails on observation and processing of dec (see note)meta.code;pos.eq.decintpmraCat. proper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullableeqpmraEquinox of cat. PM in RAyrtime.equinox;pos.pm;pos.eq.rafloatnullableeppmraEpoch of cat. PM in RAyrtime.epoch;pos.pm;pos.eq.rafloatnullablee_pmraMean error in the proper motion in RA according to the catalogdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablenobpmraNumber of observations combined into the proper motion in RAmeta.number;obsfloatnullablepmraflagType of PM RA; see notemeta.code;pos.pm;pos.eq.rashortnullablepmdeCat. proper motion in declinationdeg/yrpos.pm;pos.eq.decfloatnullableeqpmdeEquinox of cat. PM in Decyrtime.equinox;pos.pm;pos.eq.decfloatnullableeppmdeEpoch of cat. PM in declinationyrtime.epoch;pos.pm;pos.eq.decfloatnullablee_pmdeMean error in the proper motion in Dec according to the catalogdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobpmdeNumber of observations combined into the proper motion in Declinationmeta.number;obsfloatnullablepmdeflagType of PM Dec; see notemeta.code;pos.pm;pos.eq.decshortnullable
arigfh.unidentifiedThe objects in the gfh table that could not be matched with objects in -the master catalog by ARIGFH.872720catanObject number in source catalog, ARI assignedmeta.idintindexedcatidCatalog designation as in arigfh.katkatmeta.id.crosscharindexed
arihipARIHIP astrometric catalogue The catalogue ARIHIP has been constructed by selecting the 'best -data' for a given star from combinations of HIPPARCOS data with Boss' -GC and/or the Tycho-2 catalogue as well as the FK6. It provides 'best -data' for 90 842 stars with a typical mean error of 0.89 mas/year -(about a factor of 1.3 better than Hipparcos for this sample of -stars).arihip.main The catalogue ARIHIP has been constructed by selecting the 'best -data' for a given star from combinations of HIPPARCOS data with Boss' -GC and/or the Tycho-2 catalogue as well as the FK6. It provides 'best -data' for 90 842 stars with a typical mean error of 0.89 mas/year -(about a factor of 1.3 better than Hipparcos for this sample of -stars).90842hipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997).meta.id;meta.mainintindexedprimarysrcselSource of the astrometric solutionmeta.codecharnullableraj2000Right ascension from a single-star solutiondegpos.eq.ra;meta.maindoubleindexeddej2000Declination from a single-star solutiondegpos.eq.dec;meta.maindoubleindexedpmraProper motion in right ascension times cos(delta) for a single-star solution.deg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in declination for a single-star solution.deg/yrpos.pm;pos.eq.decfloatnullablet_raCentral epoch of RA (SI)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_raError in RA from the single star solution, with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmraMean error in PM(RA)*cos(delta) from the single star solutiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_deCentral epoch of Dec (SI)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_deError in Dec from the single star solutiondegstat.error;pos.eq.decfloatnullableerr_pmdeMean error in PM(Dec) form the single star solutiondeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxParallax used in deriving the data of the star in the catalogue selected for the ARIHIP. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax (see Kp).degpos.parallaxfloatnullablee_parallaxMean error of the parallaxdegstat.error;pos.parallaxfloatnullablekpSource of the parallax: H Hipparcos, P photometric parallaxmeta.ref;pos.parallaxcharnullablevradRadial velocity as used in calculating the foreshortening effect.km/sphys.veloc;pos.heliocentricfloatnullablemvVisual magnitude taken from the HIPPARCOS cataloguemagphot.mag;em.opt.VfloatindexednullablekmVariability flag. See note.meta.code;src.varcharnullablekbinBinarity flag. See note.meta.code.multipcharnullablekdmuBased on Delta mu, 1 is a single-star candidate, 2 is a Delta mu binary, and empty values mean uncertain casesmeta.code.multipcharnullablekaeMeasure of astrometric quality between 1 and 3, higher is better. Empty values mean the star is not 'astrometrically excellent'.meta.code.qualcharnullableraltpRight ascension in LTP modedegpos.eq.radoublenullabledeltpDeclination in LTP modedegpos.eq.decdoublenullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablet_raltpCentral epoch of RA (LTP)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_raltpError in RA (LTP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_deltpCentral epoch of Dec (LTP)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_deltpError in Dec (LTP)degstat.error;pos.eq.decfloatnullableerr_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerastpRight ascension in STP modedegpos.eq.radoublenullabledestpDeclination in STP modedegpos.eq.decdoublenullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablet_rastpCentral epoch of RA (STP)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_rastpError in RA (STP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_destpCentral epoch of Dec (STP)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_destpError in Dec (STP)degstat.error;pos.eq.decfloatnullableerr_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerahipRight ascension in HIP modedegpos.eq.radoublenullabledehipDeclination in HIP modedegpos.eq.decdoublenullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablet_rahipCentral epoch of RA (HIP)yrstat.error;time.epoch;pos.eq.rafloatnullableerr_rahipError in RA (HIP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullableerr_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablet_dehipCentral epoch of Dec (HIP)yrstat.error;time.epoch;pos.eq.decfloatnullableerr_dehipError in Dec (HIP)degstat.error;pos.eq.decfloatnullableerr_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxsiParallax obtained in solution SIdegpos.parallaxfloatnullableerr_parallaxsiError in parallax obtained in solution SIdegstat.error;pos.parallaxfloatnullableparallaxstpParallax obtained in solution STPdegpos.parallaxfloatnullableerr_parallaxstpError in parallax obtained in solution STPdegstat.error;pos.parallaxfloatnullableparallaxhipParallax obtained in solution HIPdegpos.parallaxfloatnullableerr_parallaxhipError in parallax obtained in solution HIPdegstat.error;pos.parallaxfloatnullableffhF-Measure for proper motions FK5 proper motions vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullableff0hF-Measure for proper motions original catalogue positions vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullableff0gchF-Measure for proper motions GC positions vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullablef0fF-Measure for proper motions FK5 and Hipparcos positions vs. FK5 proper motionsstat.fit.goodness;pos.pm;arith.difffloatnullableft2hF-Measure for proper motions Tycho2 and Hipparcos proper motionsstat.fit.goodness;pos.pm;arith.difffloatnullableflagsBinarity evidence and variability flags (see note)meta.codecharnullable
augerPierre Auger Observatory public dataThis dataset comprises the public data observed by the Pierre Auger -cosmic ray observatory, which is 1% of its total data. It contains -28493 events between 0.1 and 49.7 EeV collected between 2004 and 2013.auger.main Detection parameters of cosmic ray source candidates recorded by the -Pierre Auger Telescope. This table can be queried on the web at -http://dc.g-vo.org/auger/q/cone/form .28493eventidAuger event numbermeta.id;meta.maincharraj2000Incoming cosmic ray direction, RAdegpos.eq.ra;meta.mainfloatdej2000Incoming cosmic ray direction, Declinationdegpos.eq.dec;meta.mainfloatnstatNumber of stations participating in an eventmeta.number;obsshortcreReconstructed energy of the cosmic ray particleEeVphys.energyfloatmjdObservation time, Modified Julian Daytime.epoch;obsfloatgallonGalactic longitudedegpos.galactic.londoublegallatGalactic latitudedegpos.galactic.latdouble
bgdsBGDS time series -From the Bochum Galactic Disk Survey, time series have been obtained in the -r and i bands on an (up to) nightly basis. Depending on the field, the time -series contain up to more than 300 nights over more than 7 years. Each -measurement represents the averaged flux over 10 minutes of observation -(from 9 averaged 10s images). - -The Bochum Galactic Disk Survey is an ongoing project to monitor the -stellar content of the Galactic disk in a 6 degree wide stripe centered on -the Galactic plane. The data has been recorded since mid-2010 in Sloan r -and i simultaneously with the Robotic Bochum Twin Telescope (RoBoTT) at the -Universitaetssternwarte Bochum near Cerro Armazones in the Chilean Atacama -desert. It contains measurements of about 2x10^7 stars over more than seven -years. Additionally, intermittent measurements in Johnson UVB and Sloan z -have been recorded as well.bgds.data The Bochum Galactic Disk Survey is an ongoing project to monitor the -stellar content of the Galactic disk in a 6 degree wide stripe -centered on the Galactic plane. The data has been recorded since -mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at -the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean -Atacama desert. It contains measurements of about 2x10^7 stars over -more than seven years. Additionally, intermittent measurements in -Johnson UVB and Sloan z have been recorded as well.64413accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldSurvey field observed.meta.id;obs.fieldcharindexednullableexposureEffective exposure time (sum of exposure times of all images contributing here).stime.duration;obs.exposurefloatnullableairmassAirmass at mean epochobs.airMassfloatnullablemoondistMoon distance at mean epochdegobs.paramfloatnullablepub_didDataset identifier assigned by the publishermeta.id;meta.maincharnullable
bgds.phot_all All mean photometry of bgds in one table. It may be simpler to write -queries against the split-band tables phot_band. Measurements in -different fields and bands have not been merged, as that procedure is -too error-prone in crowded milky way regions.band_nameThe band the mean photometry is given for.meta.id;instr.filtercharnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullableerr_magError in mean magnitude in this bandmagstat.error;phot.magfloatnullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablefluxMean flux in this band; this is computed from the mean magnitude based on Landolt standard stars.mJyphot.flux;stat.meanfloatnullableerr_fluxError in mean flux in this bandmJystat.error;phot.fluxfloatnullablenobsNumber of observations in this light curvemeta.number;obsshort
bgds.ssa_time_series This table contains about metadata about the photometric time series -from BGDS in IVOA SSA format. The actual data is available through a -datalink service or in the phot_i and phot_r tables.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullableobs_idMain identifier of this observation (a single object may have multiple observations in different bands and fields)meta.id;meta.maincharnullabletime_minFirst timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.mindoublenullabletime_maxLast timestamp in time series (MJD Topocentric UTC)dtime.epoch;stat.maxdoublenullableampDifference between brightest and weakest observation.magphot.mag;arith.difffloatnullablemean_magMean magnitude in band given in phot_band.magphot.mag;stat.meanfloatnullablefieldSurvey field observed.meta.id;obs.fieldcharnullableraICRS right ascension for this object.pos.eq.ra;meta.maindoublenullabledecICRS declination for this object.pos.eq.dec;meta.maindoublenullablemjdsAn array containing the epochs of the time seriesdtime.epochdoublenullablemagsAn array containing the values of the time series.magphot.magfloatnullable
boydendeBoyden Station ADH Plates in GermanyThe Armagh-Dunsink-Harvard Becker-Schmidt Telescope was deployed at -Boyden Station, Maselspoort South Africa between 1965 and 1970. During -that time, astronomers from Bamberg, Heidelberg, Hamburg and Münster -took astronomical images there, with a focus on old star clusters, the -Magellanic clouds, and the southern milky way. This service provides -scans of the plates obtained.boydende.dataThe Armagh-Dunsink-Harvard Becker-Schmidt Telescope was deployed at -Boyden Station, Maselspoort South Africa between 1965 and 1970. During -that time, astronomers from Bamberg, Heidelberg, Hamburg and Münster -took astronomical images there, with a focus on old star clusters, the -Magellanic clouds, and the southern milky way. This service provides -scans of the plates obtained.244accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableexposureEffective exposure timestime.duration;obs.exposurefloatnullableobjectSpecial object on platemeta.idcharnullablestart_timeStart of exposuredtime.start;obsdoublenullableend_timeEnd of exposuredtime.end;obsdoublenullablewfpdb_idPlate identifier as in the WFPDBmeta.idcharnullablequalityPlate Qualitymeta.notecharnullablefilterFilter used (NULL if clear)meta.id;instr.filtercharnullableemulsionPlate emulsioninstr.plate.emulsioncharnullableobsnotesObservation Notesmeta.notecharnullabledatalink_urlURL to a datalink document for this plate (ancillary files, cutouts)meta.ref.urlcharnullableenvelopePlate envelope with plate metadatameta.ref.urlcharnullablepub_didGlobally unique dataset identifiercharindexednullable
browndwarfsDwarfArchives.org – Photometry, spectroscopy, and astrometry of L, T, -and Y dwarfsA catalogue of brown dwarfs produced by -Gelino et al. The database reflects the state of -http://www.dwarfArchives.org on 2015-09-29.browndwarfs.catA catalogue of brown dwarfs produced by -Gelino et al. The database reflects the state of -http://www.dwarfArchives.org on 2015-09-29.1281designationDesignation, typically from 2MASSmeta.id;meta.maincharnullableraj2000RA J2000.0degpos.eq.ra;meta.mainfloatindexednullabledej2000Dec J2000.0degpos.eq.dec;meta.mainfloatindexednullablejmagMagnitude in the J bandmagphot.mag;em.IR.JfloatnullableerrjmagError in magnitude in the J bandmagstat.error;phot.mag;em.IR.JfloatnullablehmagMagnitude in the H bandmagphot.mag;em.IR.HfloatnullableerrhmagError in magnitude in the H bandmagstat.error;phot.mag;em.IR.HfloatnullablekmagMagnitude in the K bandmagphot.mag;em.IR.KfloatnullableerrkmagError in magnitude in the K bandmagstat.error;phot.mag;em.IR.KfloatnullableparallaxParallax as reported by parallax_paper.degpos.parallaxfloatnullableparallax_errorError in parallax as reported by parallax_paper.degstat.error;pos.parallaxfloatnullableparallax_paperReference to the paper the parallax was taken frommeta.bib;pos.parallaxcharnullablepm_totTotal proper motiondeg/yrpos.pmfloatnullablepm_tot_errError in total proper motion.deg/yrstat.error;pos.pmfloatnullablepm_paPosition angle of proper motiondegpos.posAng;pos.pmfloatnullablepm_pa_errorError in the position angle of the proper motion.degstat.error;pos.posAng;pos.pmfloatnullablepm_paperPaper the proper motion was taken from.meta.bib;pos.pmcharnullablespectral_optSpectral type inferred from observation in visible lightsrc.spType;em.optcharindexednullablest_opt_paperReference to the paper the optical spectral type was taken frommeta.bib;src.spTypecharnullablespectral_irSpectral type inferred from observation in infraredsrc.spType;em.IRcharnullablest_ir_paperReference to the paper the infrared spectral type was taken frommeta.bib;src.spTypecharnullablediscovered_asName the object was discovered as.meta.idcharnullablediscovered_byReference to the paper in which the object was discovered.meta.bibcharnullable
califadr3CALIFA (Calar Alto Legacy Integral Field spectroscopy Area) survey DR3 -The Calar Alto Legacy Integral Field Area (CALIFA) survey provides -spatially resolved spectroscopic information for 667 galaxies, mainly -within the local universe (0.005 < z < 0.03). - -CALIFA data was obtained using the PPAK integral field unit (IFU), with a -hexagonal field-of-view of 1.3 square arcmin, with a 100% covering factor -by adopting a three-pointing dithering scheme. has been taken in two -setups: V500 (6 Å bin size, 646 galaxies) and V1200 (2.3 Å bin size, 484 -galaxies). A final product ("COMBO") combining both data sets, covering -3700-7500 Å at 6 Å bin size, is made availble for 484 galaxies. - -CALIFA is a legacy survey, intended for the community. This is the (final) -Data Release 3.califadr3.cubes Metadata for the CALIFA data cubes as delivered by the project.1574accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullables_raRight ascension of galaxy center, J2000, from NEDdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDeclination of galaxy center, J2000, from NEDdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullableobs_ext_meanMean atmospheric extinction in V band over all pointings.magobs.atmos.extinction;em.opt.V;stat.meanfloatnullableobs_ext_maxMaximal atmospheric extinction in V band band among all pointings.magobs.atmos.extinction;em.opt.V;stat.maxfloatnullableobs_ext_rmsRMS atmospheric extinction in V band band over all pointingsmagstat.error;obs.atmos.extinction;em.opt.Vfloatnullableflag_obs_extQuality flag for atmospheric extinction in V band (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.atmos.extinction;em.opt.Vshortnullableobs_am_meanMean airmass (secz) over all pointings.magobs.airMass;stat.meanfloatnullableobs_am_maxMaximal airmass (secz) band among all pointings.magobs.airMass;stat.maxfloatnullableobs_am_rmsRMS airmass (secz) band over all pointingsmagstat.error;obs.airMassfloatnullableflag_obs_amQuality flag for airmass (secz) (determined as the most severe over mean, max, and rmsmeta.code.qual;obs.airMassshortnullablered_disp_meanMean spectral dispersion FWHM over all pointings.Angstrominstr.dispersion;stat.meanfloatnullablered_disp_maxMaximal spectral dispersion FWHM band among all pointings.Angstrominstr.dispersion;stat.maxfloatnullablered_disp_rmsRMS spectral dispersion FWHM band over all pointingsAngstromstat.error;instr.dispersionfloatnullableflag_red_dispQuality flag for spectral dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_cdisp_meanMean cross-dispersion FWHM over all pointings.pixinstr.dispersion;stat.meanfloatnullablered_cdisp_maxMaximal cross-dispersion FWHM band among all pointings.pixinstr.dispersion;stat.maxfloatnullablered_cdisp_rmsRMS cross-dispersion FWHM band over all pointingspixstat.error;instr.dispersionfloatnullableflag_red_cdispQuality flag for cross-dispersion FWHM (determined as the most severe over mean, max, and rmsmeta.code.qual;instr.dispersionshortnullablered_resskyline_minFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), minimum over all pointingscountstat.fit.residual;spect.line;stat.minfloatnullablered_resskyline_maxFlux residual of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullablered_rmsresskyline_maxRMS flux residual over all fibers of a bright skyline (at 557.7 nm for V500, 435.8 nm for V1200), maximum over all pointingscountstat.fit.residual;spect.line;stat.maxfloatnullableflag_red_skylinesFlag denoting problems with the sky substractionmeta.code.qualshortnullablered_meanstraylight_maxMaximum of mean straylight intensity over all pointingscountinstr.background;stat.meanfloatnullablered_maxstraylight_maxMaximum of maximum straylight intensity over all pointingscountinstr.background;stat.maxfloatnullablered_rmsstraylight_maxMaximum of RMS straylight intensity over all pointingscountinstr.backgroundfloatnullableflag_red_straylightFlag for critical straylight.meta.code.qualshortnullableobs_skymag_meanMean V band sky surface brightness over all pointings.mag/arcsec**2phot.mag.sb;instr.skyLevel;em.opt.V;stat.meanfloatnullableobs_skymag_rmsRMS of V band sky surface brightness over all pointings.mag/arcsec**2stat.error;phot.mag.sb;instr.skyLevel;em.opt.Vfloatnullableflag_obs_skymagFlag for critical sky surface brightness.meta.code.qualshortnullablered_limsb3-sigma limiting surface brightness in B band in mag.mag/arcsec**2phot.mag.sb;em.opt.B;stat.minfloatnullablered_limsbflux3-sigma limiting surface brightness in B band as flux.erg.cm**-2.s**-1.Angstrom**-1.arcsec**-2floatnullableflag_red_limsbFlag for critical limiting surface brightness sensitivity.meta.code.qualshortnullablered_frac_bigerrFraction of bad pixels (error larger than five times the value) in this cube.instr.det.noise;arith.ratiofloatnullableflag_red_errspecFlag indicating excessive bad pixels.meta.code.qualshortnullablecal_qflux_gAverage flux ratio relative to SDSS g mean over all pointingsphot.flux;em.opt.V;arith.ratiofloatnullablecal_qflux_rAverage flux ratio relative to SDSS r mean over all pointingsphot.flux;em.opt.R;arith.ratiofloatnullablecal_qflux_rmsAverage flux ratio relative to SDSS g and r RMS over all pointingsstat.error;em.opt;arith.ratiofloatnullableflag_cal_specphotoFlag for problems with spectro-photometric calibration.meta.code.qualshortnullablecal_rmsvelmeanRMS of radial velocity residuals of estimates based on 3 or 4 spectral subranges wrt the estimates from the full spectrum.km/sstat.error;instr.calibfloatnullableflag_cal_wlFlag for critical wavelength calibration stability.meta.code.qualshortnullableflag_cal_imgqualFlag for visually evident problems in this cubemeta.code.qualshortnullableflag_cal_specqualFlag for visually evident problems in a 30''-aperture spectrum generated from this cubemeta.code.qualshortnullablecal_flatsdssFlag for visually evident problems in the `SDSS flat' (see source paper); NULL here means: no SDSS flat applied.meta.code.qualshortnullableflag_cal_registrationFlag for visually evident problems in the registration of the synthetic broad-band image with SDSS and related procedures.meta.code.qualshortnullableflag_cal_v1200v500Set if a visual check for the 30''-aperture integrated spectra in V500, V1200, and COMB showed problems.meta.code.qualshortnullableobs_seeing_meanMean FWHM seeing over all pointingsarcsecinstr.obsty.seeing;stat.meanfloatnullableobs_seeing_rmsRMS of FWHM seeing over all pointingsarcsecstat.error;instr.obsty.seeingfloatnullablecal_snr1hlrSignal to noise ratio at the half-light ratio.stat.snrfloatnullablenotesNotesmeta.notecharnullablesetupInstrument setup (V500, V1200, or COMBO)meta.code;instrcharnullable
califadr3.fluxposv1200 Data cubes of positions and fluxes in the optical for a sample of -galaxies, obtained by the CALIFA project in the v1200 setup. - -Note that due to the dithering scheme, the points here do not actually -correspond to raw measurements but instead represent a reduction of -several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.fluxposv500 Data cubes of positions and fluxes in the optical for a sample of -galaxies, obtained by the CALIFA project in the v500 setup. - -Note that due to the dithering scheme, the points here do not actually -correspond to raw measurements but instead represent a reduction of -several measurements.lambdaWavelengthAngstromfloatnullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoublenullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoublenullable
califadr3.fluxv1200Flux and errors versus position for CALIFA setup v1200. Positions are -pixel indices into the CALIFA cubes. The associate positions are in -califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, -yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.fluxv500Flux and errors versus position for CALIFA setup v500. Positions are -pixel indices into the CALIFA cubes. The associate positions are in -califadr.spectra; use "JOIN califadr3.spectra USING (califaid, xindex, -yindex)" to join that table (or use the fluxpos tables).2147483647lambdaWavelengthAngstromfloatindexednullablefluxFlux1e-19J/(s.m**2.Angstrom)floatnullableerrorError in Flux1e-23J/(s.cm**2.Angstrom)floatnullablecalifaidCALIFA id number of the target.meta.idshortindexedxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedcalifadr3.spectracalifaidcalifaidxindexxindexyindexyindex
califadr3.objects Object data for DR3 sample. - -The photometric and derived quantities are from growth curve analysis -of the SDSS images for galaxies from the mother sample -(califaid<1000), from SDSS DR7/12 photometry otherwise.667target_nameObject a targeted observation targetedmeta.id;srcobscore:Target.NamecharnullablecalifaidCALIFA internal object keymeta.id;meta.mainshortraj2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.ra;meta.maindoublenullabledej2000Right ascension of the galaxy center, J2000 (from NED)degpos.eq.dec;meta.maindoublenullableredshiftRedshift, from growth curve analysis photometry for mother sample galaxies, from SDSS DR7/12 petrosian photometry otherwise.src.redshiftfloatnullablesdss_zRedshift taken from SDSS DR7src.redshiftfloatnullablemaj_axisApparent isophotal major axis from SDSSarcsecphys.angSize;srcfloatnullablemstarStellar masslog(solMass)phys.massfloatnullablemstar_min3 sigma lower limit of Stellar masslog(solMass)phys.mass;stat.minfloatnullablemstar_max3 sigma upper limit of Stellar masslog(solMass)phys.mass;stat.maxfloatnullablechi2χ² of best fitstat.fit.chi2floatnullablevmax_nocorrSurvey volume for this galaxy from apparent isophotal diameter and measured redshift (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablevmax_denscorrV_max additionally corrected for cosmic variance (cf. 2014A&A...569A...1W)Mpc**3stat.weightfloatnullablemaguMagnitude in the u band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ufloatnullableerr_maguError in m_ustat.error;phot.mag;em.opt.Ufloatnullableu_extExtinction in the u bandphys.absorption;em.opt.Ufloatnullableabs_u_min3 sigma lower limit of the absolute magnitude in uphot.mag;em.opt.U;stat.minfloatnullableabs_u_max3 sigma upper limit of the absolute magnitude in uphot.mag;em.opt.U;stat.maxfloatnullablemaggMagnitude in the g band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Vfloatnullableerr_maggError in m_gstat.error;phot.mag;em.opt.Vfloatnullableg_extExtinction in the g bandphys.absorption;em.opt.Vfloatnullableabs_g_min3 sigma lower limit of the absolute magnitude in gphot.mag;em.opt.V;stat.minfloatnullableabs_g_max3 sigma upper limit of the absolute magnitude in gphot.mag;em.opt.V;stat.maxfloatnullablemagrMagnitude in the r band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Rfloatnullableerr_magrError in m_rstat.error;phot.mag;em.opt.Rfloatnullabler_extExtinction in the r bandphys.absorption;em.opt.Rfloatnullableabs_r_min3 sigma lower limit of the absolute magnitude in rphot.mag;em.opt.R;stat.minfloatnullableabs_r_max3 sigma upper limit of the absolute magnitude in rphot.mag;em.opt.R;stat.maxfloatnullablemagiMagnitude in the i band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magiError in m_istat.error;phot.mag;em.opt.Ifloatnullablei_extExtinction in the i bandphys.absorption;em.opt.Ifloatnullableabs_i_min3 sigma lower limit of the absolute magnitude in iphot.mag;em.opt.I;stat.minfloatnullableabs_i_max3 sigma upper limit of the absolute magnitude in iphot.mag;em.opt.I;stat.maxfloatnullablemagzMagnitude in the z band. This is from a growth curve analysis of the SDSS imagery for galaxies in the mother sample (id<1000). Otherwiese, it is the SDSS DR7/12 petrosian magnitude.phot.mag;em.opt.Ifloatnullableerr_magzError in m_zstat.error;phot.mag;em.opt.Ifloatnullablez_extExtinction in the z bandphys.absorption;em.opt.Ifloatnullableabs_z_min3 sigma lower limit of the absolute magnitude in zphot.mag;em.opt.I;stat.minfloatnullableabs_z_max3 sigma upper limit of the absolute magnitude in zphot.mag;em.opt.I;stat.maxfloatnullablehubtypMorphological type from CALIFA's own visual classification (see 2014A&A...569A...1W for details). (M) indicates definite merging going on, (m) indicates likely merging, (i) indicates signs of interaction.src.morph.typecharminhubtypEarliest morphological type in CALIFA's estimationsrc.morph.typecharmaxhubtypLatest morphological type in CALIFA's estimationsrc.morph.typecharbarBar strength, A -- strong bar, AB -- intermediate, B -- weak bar; with minimum and maximum estimates.meta.code;src.morphcharnullableflag_release_combCube in setup COMB available?meta.code;meta.datasetshortflag_release_v1200Cube in setup V1200 available?meta.code;meta.datasetshortflag_release_v500Cube in setup V500 available?meta.code;meta.datasetshortaxis_ratiob/a axis ratio of a moment-based anaylsis of the SDSS DR7 images (cf. 2014A&A...569A...1W).phys.angSize;arith.ratiofloatnullableposition_anglePosition angle wrt north.degpos.posAngfloatnullableel_hlrPetrosian half-light radius in r bandarcsecphys.angSize;srcfloatnullablemodmag_rModel magnitude in r bandmagphot.mag;meta.modelledfloatnullablecalifadr3.cubescalifaidcalifaid
califadr3.spectra Metadata for individual spectra. Note that the spectra result from -reducing a complex dithering scheme and are not independent from one -another.5100000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio at 500 nm (V500 spectra) or 400 nm (V1200 spectra)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullableraj2000Right ascension of spectrum, ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of spectrum, ICRSdegpos.eq.dec;meta.maindoubleindexednullablecalifaidCALIFA id number of the target.meta.idshortindexedprimaryxindexX index in the CALIFA grid; V1200 indices are pixel+1000.pos.cartesian.xshortindexedprimaryyindexY index in the CALIFA grid; V1200 indexes are pixel+1000pos.cartesian.yshortindexedprimary
carsCARS survey dataImages and data from from the CFHTLS archive research survey, a -multi-band dataset spanning 37 square degrees of sky in high galactic -latitudes.cars.images -Metadata for co-added CFHTLS archive images -used for producing the CARS source list (cars.srccat).185accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldkeyCARS field designationmeta.idcharnullablefieldbandkeyCARS field designation plus bandmeta.idcharnullablencombineNumber of individual frames in this stackmeta.numberinttexptimeTotal Exposure Timestime.duration;obs.exposurefloatnullablemagzpAB Magnitude Zeropointmagphot.mag;arith.zpfloatnullablemagzperrEstimated Magnitude Zeropoint Errormagstat.error;phot.mag;arith.zpfloatnullableseeingMeasured image seeingarcsecinstr.obsty.seeingfloatnullableseeingerrMeasured image Seeing errorarcsecstat.error;instr.obsty.seeingfloatnullable
cars.srccatExtracted sources from the CARS survey, comprising positions and -multiband photometry.5200000carsidCARS object IDmeta.id;meta.maincharindexedprimaryseqnrRunning object number (in field)meta.idintraj2000Right ascension of barycenter (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of barycenter (J2000)degpos.eq.dec;meta.maindoubleindexednullablexposObject position on exposure along xpixpos.cartesian.x;instr.detfloatnullableyposObject position on exposure along ypixpos.cartesian.y;instr.detfloatnullablemagautoKron-like elliptical aperture magnitudemagphot.magfloatindexednullablemagerrautoError in Kron-like elliptical aperture magnitudemagstat.error;phot.magfloatnullablemagisouIsophotal magnitude in the u* bandmagphot.mag;em.optfloatnullablemagisoerruRMS error of isophotal magnitude in the u* bandmagstat.error;phot.mag;em.optfloatnullablemagapruFixed aperture magnitude in the u* bandmagphot.mag;em.optfloatnullablemagaprerruRMS error of fixed aperture magnitude in the u* bandmagstat.error;phot.mag;em.optfloatnullablemaglimuLimiting magnitude at object's position in u* bandmagfloatnullablemagisogIsophotal magnitude in the g' bandmagphot.mag;em.optfloatnullablemagisoerrgRMS error of isophotal magnitude in the g' bandmagstat.error;phot.mag;em.optfloatnullablemagaprgFixed aperture magnitude in the g' bandmagphot.mag;em.optfloatnullablemagaprerrgRMS error of fixed aperture magnitude in the g' bandmagstat.error;phot.mag;em.optfloatnullablemaglimgLimiting magnitude at object's position in g' bandmagfloatnullablemagisorIsophotal magnitude in the r' bandmagphot.mag;em.optfloatnullablemagisoerrrRMS error of isophotal magnitude in the r' bandmagstat.error;phot.mag;em.optfloatnullablemagaprrFixed aperture magnitude in the r' bandmagphot.mag;em.optfloatnullablemagaprerrrRMS error of fixed aperture magnitude in the r' bandmagstat.error;phot.mag;em.optfloatnullablemaglimrLimiting magnitude at object's position in r' bandmagfloatnullablemagisoiIsophotal magnitude in the i' bandmagphot.mag;em.optfloatnullablemagisoerriRMS error of isophotal magnitude in the i' bandmagstat.error;phot.mag;em.optfloatnullablemagapriFixed aperture magnitude in the i' bandmagphot.mag;em.optfloatnullablemagaprerriRMS error of fixed aperture magnitude in the i' bandmagstat.error;phot.mag;em.optfloatnullablemaglimiLimiting magnitude at object's position in i' bandmagfloatnullablemagisozIsophotal magnitude in the z' bandmagphot.mag;em.optfloatnullablemagisoerrzRMS error of isophotal magnitude in the z' bandmagstat.error;phot.mag;em.optfloatnullablemagaprzFixed aperture magnitude in the z' bandmagphot.mag;em.optfloatnullablemagaprerrzRMS error of fixed aperture magnitude in the z' bandmagstat.error;phot.mag;em.optfloatnullablemaglimzLimiting magnitude at object's position in z' bandmagfloatnullablefwhmFull width half max assuming a gaussian coredegphys.angSizefloatindexednullablefluxradiusFraction-of-light radiuspixfloatnullablemajoraxisProfile RMS along major axisdegphys.angSize.smajAxisfloatnullableminoraxisProfile RMS along minor axisdegphys.angSize.sminAxisfloatnullablethetaPosition angle (east of north) (J2000)degpos.posAngfloatnullablesgclassS/G classifier output (0..1)src.class.starGalaxyfloatnullableextflagsExtraction FlagsintmaskTrue if object is within an object maskmeta.codebooleanz_bPhotometric redshiftfloatnullablet_bMask valuefloatnullableoddsConfidence parameter for photometric redshiftfloatnullablengoodfiltersNumber of filters with good photometry for BPZmeta.code.qualintnbadfiltersNumber of filters with bad photometry for BPZmeta.code.qualintnfaintfiltersNumber of filters with faint photometry for BPZmeta.code.qualintgoodfiltersFilters with faint photometry for BPZcharnullablebadfiltersFilters with bad photometry for BPZcharnullablefaintfiltersFilters with faint photometry for BPZcharnullablefieldkeyCARS field designationmeta.idcharnullable
carsarcsGravitational arc candidates in the CFHTLS-Archive-Research Survey -CARS Candidate gravitational arcs in the 37 deg^2 of -CFHTLS-Archive-Research Survey (CARS). The data include their -post-stamp images, astrometry, photometry (u*,g',r',i'), geometric -properties (length, length-to-width ratio, profile curvature, area), -and photometric redshifts. The arc candidates were selected booth with -an automatic arcfinder, based on a tailored image segmentation and a -color selection, and by visually inspecting the survey.carsarcs.metaMagnitudes, redshifts, positions, etc. of the arcs found in CARS. Candidate gravitational arcs in the 37 deg^2 of -CFHTLS-Archive-Research Survey (CARS). The data include their -post-stamp images, astrometry, photometry (u*,g',r',i'), geometric -properties (length, length-to-width ratio, profile curvature, area), -and photometric redshifts. The arc candidates were selected booth with -an automatic arcfinder, based on a tailored image segmentation and a -color selection, and by visually inspecting the survey.90previewPreview imagemeta.ref.urlcharnullablematidIdentification number within carsarcsmeta.id;meta.maincharnullablecarsfieldCARS field identifiermeta.id;obs.fieldcharnullableraj2000Right ascension of the center, ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination of the center, ICRSdegpos.eq.dec;meta.maindoubleindexednullablearc_lengthLength of the arc (see paper for construction).degphys.angSize;srcfloatnullablearc_l_wLength to width ratio for the arc (see paper for construction).phys.size;arith.ratiofloatnullablearc_curvCurvature of the arc (see paper for construction).deg**-1src.morph.paramfloatnullablearc_areaArea of the arc (see paper for construction).deg**2phys.angSize;srcfloatnullableuprimearc u' aperture magnitude (based on segmentation)magphot.mag;em.opt.Ufloatnullableerr_uprimeError in u magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Ufloatnullablegprimearc g' aperture magnitude (based on segmentation)magphot.mag;em.opt.Vfloatnullableerr_gprimeError in g magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Vfloatnullablerprimearc r' aperture magnitude (based on segmentation)magphot.mag;em.opt.Rfloatnullableerr_rprimeError in r magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Rfloatnullableiprimearc i' aperture magnitude (based on segmentation)magphot.mag;em.opt.Ifloatnullableerr_iprimeError in i magnitude; estimated by image noise including background subtraction uncertainty.magstat.error;phot.mag;em.opt.Ifloatnullablez_lensPhotometric redshift of the lens (from CARS catalog).src.redshift.photfloatnullablez_lens_err_plusLens photometric redshift 1-sigma error taken from the CARS catalog.stat.error;src.redshift.photfloatnullablez_lens_err_minusLens photometric redshift 1-sigma error taken from the CARS catalog.stat.error;src.redshift.photfloatnullablequal_assQuality assessmentmeta.code.qualshortnullablecatnrCatalog number of previously known arcsmeta.id.crosscharnullableimg_uCARS image in the u band.meta.ref.urlcharnullableimg_gCARS image in the g band.meta.ref.urlcharnullableimg_rCARS image in the r band.meta.ref.urlcharnullableimg_iCARS image in the i band.meta.ref.urlcharnullable
casa_linesSplatalogue CASA LineTAP -This is a rendering of the `CASA Offline Splatalogue`_ in -a draft LineTAP, mainly intended to enable verification of the standard. -This is not recommended for production yet. In particular, many -InChIs are known wrong, and we have skipped several hundred lines -because we did have no InChIs for their species at all. - -.. _CASA Offline Splatalogue: https://safe.nrao.edu/wiki/bin/view/ALMA/CASA_Offline_Splat_listcasa_lines.line_tap -This is a rendering of the `CASA Offline Splatalogue`_ in -a draft LineTAP, mainly intended to enable verification of the standard. -This is not recommended for production yet. In particular, many -InChIs are known wrong, and we have skipped several hundred lines -because we did have no InChIs for their species at all. - -.. _CASA Offline Splatalogue: https://safe.nrao.edu/wiki/bin/view/ALMA/CASA_Offline_Splat_listivo://ivoa.net/std/linetap#table-1.0333480titleHuman-readable line designation.meta.idcharvacuum_wavelengthVacuum wavelength of the transitionAngstromem.wldoublevacuum_wavelength_errorTotal error in vacuum_wavelengthAngstromstat.error;em.wldoublenullablemethodMethod the wavelength was obtained with (XSAMS controlled vocabulary)meta.code.classcharnullableelementElement name for atomic transitions, NULL otherwise.phys.atmol.elementcharnullableion_chargeTotal charge (ionisation level) of the emitting particle.phys.electChargeintmass_numberNumber of nucleons in the atom or moleculephys.atmol.weightintnullableupper_energyEnergy of the upper stateJphys.energy;phys.atmol.initialdoublenullablelower_energyEnergy of the lower stateJphys.energy;phys.atmol.finaldoublenullableinchiInternational Chemical Identifier InChI.meta.id;phys.atmol;meta.maincharinchikeyThe InChi key (hash) generated from inchi.meta.id;phys.atmolchareinstein_aEinstein A coefficient of the radiative transition.phys.atmol.transProbdoublenullablexsams_uriA URI for a full XSAMS description of this line.meta.refcharnullableline_referenceReference to the source of the line data; this could be a bibcode, a DOI, or a plain URI.meta.refcharnullablenrao_formulaChemical formula in NRAO's argot.meta.id;phys.molcharnullablecommon_nameCommon name of the molecule.meta.id;phys.molcharnullablequantnrResolved Quantum Number as per http://www.cv.nrao.edu/php/splat/QuantumCode.htmlphys.atmol.configurationcharnullabledipole_momentMolecule dipole moment Sij μ²Dfloatnullable
cns5The Fifth Catalogue of Nearby Stars (CNS5) The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most -volume-complete sample of stars in the solar neighbourhood. The CNS5 -is compiled based on trigonometric parallaxes from Gaia EDR3 and -Hipparcos, and supplemented with astrometric data from Spitzer and -ground-based surveys carried out in the infrared. The CNS5 catalogue -is statistically complete down to 19.7 mag in G-band and 11.8 mag in -W1-band absolute magnitudes, corresponding to a spectral type of L8. - -Continuous updates of observational data for nearby stars from all -sources were collected and evaluated. For all known stars in the 25 pc -sphere around the Sun, the best values of positions in space, -velocities, and magnitudes in different filters are presented.cns5.main The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most -volume-complete sample of stars in the solar neighbourhood. The CNS5 -is compiled based on trigonometric parallaxes from Gaia EDR3 and -Hipparcos, and supplemented with astrometric data from Spitzer and -ground-based surveys carried out in the infrared. The CNS5 catalogue -is statistically complete down to 19.7 mag in G-band and 11.8 mag in -W1-band absolute magnitudes, corresponding to a spectral type of L8. - -Continuous updates of observational data for nearby stars from all -sources were collected and evaluated. For all known stars in the 25 pc -sphere around the Sun, the best values of positions in space, -velocities, and magnitudes in different filters are presented.5909cns5_idCNS5 designationmeta.id;meta.mainlonggj_idGliese-Jahreiss numbermeta.id.crosscharnullablecomponent_idSuffix for a component of binary or multiple systemmeta.code.multipcharnullablen_componentsTotal number of components in the systemmeta.numbershortnullableprimary_flagTrue for the primary of a multiple systemmeta.codeshortnullablegj_system_primaryGliese-Jahriess number of the primary component of the systemmeta.id.crosscharnullablegaia_edr3_idSource identifier in Gaia EDR3meta.id.crosslongnullablehip_idHipparcos identifiermeta.id.crossintnullableraRight ascensiondegpos.eq.ra;meta.maindoubleindexednullabledecDeclinationdegpos.eq.dec;meta.maindoubleindexednullableepochReference epoch for coordinatesyrtime.epochdoublenullablecoordinates_bibcodeSource of the positionmeta.bib;pos.eqcharnullableparallaxAbsolute trigonometric parallaxmaspos.parallax.trigdoublenullableparallax_errorError in parallaxmasstat.error;pos.parallax.trigfloatnullableparallax_bibcodeSource of the parallaxmeta.bib;pos.parallax.trigcharnullablepmraProper motion in right ascensionmas/yrpos.pm;pos.eq.radoublenullablepmra_errorError in pmramas/yrstat.error;pos.pm;pos.eq.radoublenullablepmdecProper motion in declinationmas/yrpos.pm;pos.eq.decdoublenullablepmdec_errorError of pmdecmas/yrstat.error;pos.pm;pos.eq.decdoublenullablepm_bibcodeSource of the proper motionmeta.bib;pos.pmcharnullablervSpectroscopic radial velocitykm/sphys.veloc;pos.barycenterdoublenullablerv_errorError in rvkm/sstat.error;phys.veloc;pos.barycenterdoublenullablerv_bibcodeSource of the radial velocitymeta.bib;phys.veloc;pos.barycentercharnullableg_magG band mean magnitude (corrected)magphot.mag;em.optfloatnullableg_mag_errorError in g_magmagstat.error;phot.mag;em.optdoublenullablebp_magGaia eDR3 integrated BP mean magnitudemagphot.mag;em.opt.bfloatnullablebp_mag_errorError in bp_magmagstat.error;phot.mag;em.opt.bdoublenullablerp_magGaia eDR3 integrated RP mean magnitudemagphot.mag;em.opt.rfloatnullablerp_mag_errorError in rp_magmagstat.error;phot.mag;em.opt.rdoublenullableg_mag_from_hipHipparcos Hp magnitude converted to the G bandmagphot.mag;em.optdoublenullableg_mag_from_hip_errorError in g_mag_from_hipmagstat.error;phot.mag;em.optdoublenullableg_rp_from_hipG - RP colour computed from Hipparcos V and Imagphot.color;em.opt.r;em.optdoublenullableg_rp_from_hip_errorError in g_rp_from_hipmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_mag_resultingResulting (e.g., deblended) G band magnitudemagphot.mag;em.optfloatnullableg_mag_resulting_errorError in g_mag_resultingmagstat.error;phot.mag;em.optdoublenullableg_rp_resultingResulting (e.g., deblended) G - RP colourmagphot.color;em.opt.r;em.optdoublenullableg_rp_resulting_errorError in g_rp_resultingmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_rp_resulting_flag0 – G-RP is deblended; 1 – G-RP is uncorrected vs. eDR3; 2 – G-RP is converted from Hipparcosmeta.code;phot.magshortnullablej_mag2MASS J band magnitudemagphot.mag;em.ir.jfloatnullablej_mag_errorError in j_magmagstat.error;phot.mag;em.ir.jfloatnullableh_mag2MASS H band magnitudemagphot.mag;em.ir.hfloatnullableh_mag_errorError in h_magmagstat.error;phot.mag;em.ir.hfloatnullablek_mag2MASS Ks band magnitudemagphot.mag;em.ir.kfloatnullablek_mag_errorError in k_magmagstat.error;phot.mag;em.ir.kfloatnullablejhk_mag_bibcodeSource of NIR magnitudesmeta.bib;phot.mag;em.ircharnullablew1_magWISE W1 band magnitudemagphot.mag;em.ir.3-4umfloatnullablew1_mag_errorError in w1_magmagstat.error;phot.mag;em.ir.3-4umfloatnullablew2_magWISE W2 band magnitudemagphot.mag;em.ir.4-8umfloatnullablew2_mag_errorError in w2_magmagstat.error;phot.mag;em.ir.4-8umfloatnullablew3_magWISE W3 band magnitudemagphot.mag;em.ir.8-15umfloatnullablew3_mag_errorError in w3_magmagstat.error;phot.mag;em.ir.8-15umfloatnullablew4_magWISE W4 band magnitudemagphot.mag;em.ir.15-30umfloatnullablew4_mag_errorError in w4_magmagstat.error;phot.mag;em.ir.15-30umfloatnullablewise_mag_bibcodeSource of MIR magnitudesmeta.bib;phot.mag;em.ircharnullable
cns5updateThe Fifth Catalogue of Nearby Stars: Continuously Updated Version -(CNS5-updated) -The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most -volume-complete sample of stars in the solar neighbourhood. This is -a continuously-updated version of the published CNS5 -(:bibcode:`2023A&A...670A..19G`). - -The CNS5 is compiled based on trigonometric parallaxes from Gaia DR3 and -Hipparcos, and supplemented with astrometric data from Spitzer and -ground-based surveys carried out in the infrared. The CNS5 catalogue is -statistically complete down to 19.7 mag in G-band and 11.8 mag in W1-band -absolute magnitudes, corresponding to a spectral type of L8. - -Continuous updates of observational data for nearby stars from all sources -were collected and evaluated. For all known stars in the 25 pc sphere -around the Sun, the best values of positions in space, velocities, and -magnitudes in different filters are presented.cns5update.main -The Fifth Catalogue of Nearby Stars (CNS5) aims to provide the most -volume-complete sample of stars in the solar neighbourhood. This is -a continuously-updated version of the published CNS5 -(:bibcode:`2023A&A...670A..19G`). - -The CNS5 is compiled based on trigonometric parallaxes from Gaia DR3 and -Hipparcos, and supplemented with astrometric data from Spitzer and -ground-based surveys carried out in the infrared. The CNS5 catalogue is -statistically complete down to 19.7 mag in G-band and 11.8 mag in W1-band -absolute magnitudes, corresponding to a spectral type of L8. - -Continuous updates of observational data for nearby stars from all sources -were collected and evaluated. For all known stars in the 25 pc sphere -around the Sun, the best values of positions in space, velocities, and -magnitudes in different filters are presented.5912cns5_idCNS5 designationmeta.id;meta.mainlonggj_idGliese-Jahreiss numbermeta.id.crosscharnullablecomponent_idDesignation of component(s) in binaries or multiple systems. This may consist of several letters if a catalogue entry corresponds to more than one component that is not split into individual entries.meta.code.multipcharnullablen_componentsTotal number of components in the systemmeta.numbershortnullableprimary_flagTrue for the primary of a multiple systemmeta.codeshortnullablegj_system_primaryGliese-Jahriess number of the primary component of the systemmeta.id.crosscharnullablegaia_dr3_idSource identifier in Gaia DR3meta.id.crosslongnullablehip_idHipparcos identifiermeta.id.crossintnullableraRight ascensiondegpos.eq.ra;meta.maindoublenullabledecDeclinationdegpos.eq.dec;meta.maindoublenullableepochReference epoch for coordinatesyrtime.epochdoublenullablecoordinates_bibcodeSource of the positionmeta.bib;pos.eqcharnullableparallaxAbsolute trigonometric parallaxmaspos.parallax.trigdoublenullableparallax_errorError in parallaxmasstat.error;pos.parallax.trigfloatnullableparallax_bibcodeSource of the parallaxmeta.bib;pos.parallax.trigcharnullablepmraProper motion in right ascensionmas/yrpos.pm;pos.eq.radoublenullablepmra_errorError in pmramas/yrstat.error;pos.pm;pos.eq.radoublenullablepmdecProper motion in declinationmas/yrpos.pm;pos.eq.decdoublenullablepmdec_errorError of pmdecmas/yrstat.error;pos.pm;pos.eq.decdoublenullablepm_bibcodeSource of the proper motionmeta.bib;pos.pmcharnullablervSpectroscopic radial velocitykm/sphys.veloc;pos.barycenterdoublenullablerv_errorError in rvkm/sstat.error;phys.veloc;pos.barycenterdoublenullablerv_bibcodeSource of the radial velocitymeta.bib;phys.veloc;pos.barycentercharnullableg_magG band mean magnitude (corrected)magphot.mag;em.optfloatnullableg_mag_errorError in g_magmagstat.error;phot.mag;em.optdoublenullablebp_magGaia DR3 integrated BP mean magnitudemagphot.mag;em.opt.bfloatnullablebp_mag_errorError in bp_magmagstat.error;phot.mag;em.opt.bdoublenullablerp_magGaia DR3 integrated RP mean magnitudemagphot.mag;em.opt.rfloatnullablerp_mag_errorError in rp_magmagstat.error;phot.mag;em.opt.rdoublenullableg_mag_from_hipHipparcos Hp magnitude converted to the G bandmagphot.mag;em.optdoublenullableg_mag_from_hip_errorError in g_mag_from_hipmagstat.error;phot.mag;em.optdoublenullableg_rp_from_hipG - RP colour computed from Hipparcos V and Imagphot.color;em.opt.r;em.optdoublenullableg_rp_from_hip_errorError in g_rp_from_hipmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_mag_resultingResulting (e.g., deblended) G band magnitudemagphot.mag;em.optfloatnullableg_mag_resulting_errorError in g_mag_resultingmagstat.error;phot.mag;em.optdoublenullableg_rp_resultingResulting (e.g., deblended) G - RP colourmagphot.color;em.opt.r;em.optdoublenullableg_rp_resulting_errorError in g_rp_resultingmagstat.error;phot.color;em.opt.r;em.optdoublenullableg_rp_resulting_flag0 – G-RP is deblended; 1 – G-RP is uncorrected vs. DR3; 2 – G-RP is converted from Hipparcosmeta.code;phot.magshortnullablej_mag2MASS J band magnitudemagphot.mag;em.ir.jfloatnullablej_mag_errorError in j_magmagstat.error;phot.mag;em.ir.jfloatnullableh_mag2MASS H band magnitudemagphot.mag;em.ir.hfloatnullableh_mag_errorError in h_magmagstat.error;phot.mag;em.ir.hfloatnullablek_mag2MASS Ks band magnitudemagphot.mag;em.ir.kfloatnullablek_mag_errorError in k_magmagstat.error;phot.mag;em.ir.kfloatnullablejhk_mag_bibcodeSource of NIR magnitudesmeta.bib;phot.mag;em.ircharnullablew1_magWISE W1 band magnitudemagphot.mag;em.ir.3-4umfloatnullablew1_mag_errorError in w1_magmagstat.error;phot.mag;em.ir.3-4umfloatnullablew2_magWISE W2 band magnitudemagphot.mag;em.ir.4-8umfloatnullablew2_mag_errorError in w2_magmagstat.error;phot.mag;em.ir.4-8umfloatnullablew3_magWISE W3 band magnitudemagphot.mag;em.ir.8-15umfloatnullablew3_mag_errorError in w3_magmagstat.error;phot.mag;em.ir.8-15umfloatnullablew4_magWISE W4 band magnitudemagphot.mag;em.ir.15-30umfloatnullablew4_mag_errorError in w4_magmagstat.error;phot.mag;em.ir.15-30umfloatnullablewise_mag_bibcodeSource of MIR magnitudesmeta.bib;phot.mag;em.ircharnullable
cs82morphozPhotometric redshifts in Stripe 82 This is a catalogue of photometric redshifts of galaxies in the -Stripe 82 obtained when morphology (galaxy size, ellipticity, Sérsic -index, and surface brightness) are included in training on galaxy -samples from the SDSS and the CFHT Stripe-82 Survey (CS82). Our -redshifts yield a 68th percentile error of 0.058(1 + z), and a outlier -fraction of 5.2 per cent.cs82morphoz.main This is a catalogue of photometric redshifts of galaxies in the -Stripe 82 obtained when morphology (galaxy size, ellipticity, Sérsic -index, and surface brightness) are included in training on galaxy -samples from the SDSS and the CFHT Stripe-82 Survey (CS82). Our -redshifts yield a 68th percentile error of 0.058(1 + z), and a outlier -fraction of 5.2 per cent.5800000objid_cs82Identifier built as im_num*1000000+se_idmeta.id;meta.mainintindexedprimaryraICRS Right Ascensiondegpos.eq.ra;meta.maindoubleindexednullabledecICRS Declinationdegpos.eq.dec;meta.maindoubleindexednullableflagsSource extraction quality flag (ranges from 0 to 3, with 0 being the best)meta.codeshortweightlensFit shape measurement confidence. weight>0 indicates good shape measurementstat.weightfloatnullablefitclasslensFit star-galaxy classifier: 1=stars; 0=galaxies; -1=no usable data; -2=blended objects; -3=miscellaneous reasons; -4=chi-square exceeded critical valuemeta.code;src.classshortmag_autoCS82 Kron i-band magnitudemagphot.mag;em.opt.ifloatindexednullablemagerr_autoCS82 Kron i-band magnitude error. Signal-to-noise ratio is 1.086/MAGERR_AUTOmagstat.error;phot.mag;em.opt.ifloatnullablemag_expCS82 exponential fit i-band magnitudemagphot.mag;em.opt.ifloatnullablemag_psfCS82 PSF i-band magnitudemagphot.mag;em.opt.ifloatnullablereff_expExponential fit effective radiusarcsecphys.angsize;srcfloatnullableaspect_expExponential fit axis-ratiosrc.morph.paramfloatnullablemu_mean_expExponential fit mean surface brightnessmag/arcsec**2phot.mag.sb;em.opt.ifloatnullablep_expExponential shape probability: ~1 -> disc galaxy; ~0 -> elliptical galaxystat.fit.goodnessfloatnullablen_serSersic indexstat.fit.paramfloatnullablespread_model_serSersic spread model, the star-galaxy separator we used for this study. All objects in this catalogue have SPREAD_MODEL_SER>0.008, which are considered extended objects (galaxies).stat.fit.paramfloatnullablelensLensing tag. Objects with lens=1 are objects from the lensing subsample (fitclass=0, weight>0)meta.codeshortobjid_sdssSDSS object ID for objects with matched ugriz broadband magnitudes (if available)meta.id.crosslongnullablemag_dered_uSDSS dereddened u-band magnitudemagphot.mag;em.opt.Ufloatnullablemag_dered_gSDSS dereddened g-band magnitudemagphot.mag;em.opt.Vfloatnullablemag_dered_rSDSS dereddened r-band magnitudemagphot.mag;em.opt.Rfloatnullablemag_dered_iSDSS dereddened i-band magnitudemagphot.mag;em.opt.Ifloatnullablemag_dered_zSDSS dereddened z-band magnitudemagphot.mag;em.opt.IfloatnullablezspecSpectroscopic redshift from source given in source_specsrc.redshiftfloatnullablezphotPhotometric redshift estimated using inputs ugriz+morphologysrc.redshiftfloatnullablezmorphPhotometric redshift estimated using inputs i+morphologysrc.redshiftfloatnullablezbestBest redshift for this object, in order of priority: zspec, zphot, zmorphsrc.redshiftfloatindexednullableodds_photOdds value for zphotstat.fit.goodnessfloatnullableodds_morphOdds value for zmorphstat.fit.goodnessfloatnullableodds_bestOdds value for zbest (=1 if zspec is used)stat.fit.goodnessfloatnullablesource_specSource of spectroscopy: SDSS, BOSS, DEEP2, WIGGLEZ or VVDSmeta.bibcharnullableclass_specClass of object based on spectral fit: GALAXY or QSOmeta.code.classcharnullable
cstlConstellations as Polygons This table contains constellation data from Davenhall et al, -ivo://cds.vizier/vi/49, converted to ADQL-queriable polygons. The -polygons use the J2000 points, and we skip the interpolated points.cstl.geo This table contains constellation data from Davenhall et al, -ivo://cds.vizier/vi/49, converted to ADQL-queriable polygons. The -polygons use the J2000 points, and we skip the interpolated points.87abbrevAbbreviation of the constellation namemeta.id;meta.maincharnullablenameFull name of the constellation namemeta.idcharnullablepThe coverage of the constallationposdoubleindexednullableraRepresentative RA (actually, the mean of the vertices)degpos.eq.ra;meta.mainfloatnullabledecRepresentative Dec (actually, the mean of the vertices)degpos.eq.dec;meta.mainfloatnullable
danishMiNDSTEP Danish Observatory Lens ImagesTBDdanish.dataTBD2469accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableobservatObservatory the exposure was prepared atcharnullableinstrumemeta.id;instrcharnullabledetnamecharnullableorignameName given at La Sillameta.id;meta.filecharnullableobjectObject observedmeta.id;meta.maincharexptimeExposure timestime.duration;obs.exposurefloatnullabletm_startUT start timetime.epoch;obs.exposurecharnullabletm_endUT end timetime.epoch;obs.exposurecharnullablefilter_aFilter used on wheel Ameta.id;instr.filtercharnullablefilter_bFilter used on wheel Bmeta.id;instr.filtercharnullablefilterFilter usedmeta.id;instr.filter;meta.maincharnullablestSidereal time at startsfloatnullableraRight ascension at startdegpos.eq.ra;meta.mainfloatnullabledecDeclination at startdegpos.eq.dec;meta.mainfloatnullablehaHour Angle at startfloatnullablezdistZenith distance at startdegpos.az.zdfloatnullable
dfbsplatesDigitized First Byurakan Survey (DFBS) Plate Scans -The First Byurakan Survey (FBS) is the largest and the first systematic -objective prism survey of the extragalactic sky. It covers 17,000 sq.deg. -in the Northern sky together with a high galactic latitudes region in the -Southern sky. This service serves the scanned objective prism images -and offers SODA-based cutouts.dfbsplates.main -The First Byurakan Survey (FBS) is the largest and the first systematic -objective prism survey of the extragalactic sky. It covers 17,000 sq.deg. -in the Northern sky together with a high galactic latitudes region in the -Southern sky. This service serves the scanned objective prism images -and offers SODA-based cutouts.1711accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableplateIdentifier (plate number) for the DFBS plate.meta.idcharnullableexptimeExposure time.sfloatnullablepublisher_didDataset identifier assigned by the publisher.meta.ref.urlcharnullable
dfbsspecDigitized First Byurakan Survey (DFBS) Extracted Spectra -The First Byurakan Survey (FBS) is the largest and the first systematic -objective prism survey of the extragalactic sky. It covers 17,000 sq.deg. -in the Northern sky together with a high galactic latitudes region in the -Southern sky. The FBS has been carried out by B.E. Markarian, V.A. -Lipovetski and J.A. Stepanian in 1965-1980 with the Byurakan Observatory -102/132/213 cm (40"/52"/84") Schmidt telescope using 1.5 deg. prism. Each -FBS plate contains low-dispersion spectra of some 15,000-20,000 objects; -the whole survey consists of about 20,000,000 objects.dfbsspec.raw_spectra Raw metadata for the spectra, to be combined with image metadata like -date_obs and friends for a complete spectrum descriptions. This also -contains spectral and flux points in array-valued columns.24000000accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexedprimaryplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableobjectidSynthetic object id assigned by DFBS.meta.idcharnullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullableskySky background estimation from the scan (uncalibrated).instr.skyLevelfloatnullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullablepx_lengthNumber of points in this spectrumfloatnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharindexednullable
dfbsspec.spectraThis table contains basic metadata as well as the spectra from the -Digital First Byurakan Survey (DFBS).accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullablespecidIdentifier of the spectrum built from the plate identifier, a -, and the object position as in objectid.meta.id;meta.maincharindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullableposThe object position as s pgsphere spoint.pos.eqdoublenullablesp_classQuality indicator: OK of undisturbed spectra of sufficiently bright objects, NL if disturbers are nearby, U for objects unclassifiable because of lack of signal.meta.code.qualcharnullablepx_lengthNumber of points in this spectrumfloatnullablefluxFlux points of the extracted spectrum (arbitrary units)phot.flux.density;em.wlfloatnullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullablesnrEstimated signal-to-noise ratio for this spectrum.stat.snrfloatnullablelam_minMinimal wavelength in this spectrum (the longest wavelength is always 690 nm).mem.wl;stat.minfloatindexednullablepx_xLocation of the spectrum on the plate scan, x coordinate.pixelpos.cartesian.x;instrfloatnullablepx_yLocation of the spectrum on the plate scan, y coordinate.pixelpos.cartesian.y;instrfloatnullablepos_angPosition angle of the spectrum on the plate, north over east.degpos.posAngfloatnullableepochDate of observation from WFPDB (this probably does not include the time).dtime.epochdoubleindexednullableexptimeExposure time from WFPDB.stime.duration;obs.exposurefloatnullableemulsionEmulsion used in this plate from WFPDB.instr.plate.emulsioncharnullablespectralSpectral points of the extracted spectrum (wavelengths) as an array (the points are the same for all spectra; the array in this column is cropped at the blue end to match the length of flux).mem.wlfloatnullablecutout_linkCutout of the image this spectrum was extracted frommeta.ref.urlcharnullable
dfbsspec.ssaA view providing standard SSA metadata for DBFS metadata in -dfbsspec.spectra23213283accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablemagbSource object magnitude in Johnson Bmagphot.mag;em.opt.BfloatnullablemagrSource object magnitude in Johnson Rmagphot.mag;em.opt.RfloatnullableplateNumber of the plate this spectrum was extracted from. Technically, this is a foreign key into dfbs.plates.charindexednullableraICRS RA of the source of this spectrum.degpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec of the source of this spectrum.degpos.eq.dec;meta.maindoubleindexednullable
dmubinDelta-mu BinariesA collection of binary stars with a difference in instantaneous proper -motion as measured by HIPPARCOS and the long-term proper motion.dmubin.mainA collection of binary stars with a difference in instantaneous proper -motion as measured by HIPPARCOS and the long-term proper motion.8039hipnoCatalog number in Hipparcos catalogmeta.id;meta.mainintraj2000Right ascension from Hipparcosdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination from Hipparcosdegpos.eq.dec;meta.maindoubleindexednullablecompComponent for resolved binariesmeta.codecharnullablemvVisual magnitudemagphot.mag;em.opt.VfloatnullablecolorColor index B-V, Hipparcos V magnitudemagphot.color;em.opt.B;em.opt.VfloatnullableparallaxParallax from Hipparcosmaspos.parallax.trigfloatnullableffhF-Measure for proper motions FK5 vs. Hipparcosstat.fit.goodness;pos.pm;arith.difffloatnullablef0fF-measure for proper motions from FK5 vs. mu0Fstat.fit.goodness;pos.pm;arith.difffloatnullablef0hF-measure for proper motions from Hipparcos vs. mu0Fstat.fit.goodness;pos.pm;arith.difffloatnullablef0gchF-measure for proper motions from Hipparcos vs. mu0Gstat.fit.goodness;pos.pm;arith.difffloatnullableft2hF-measure for proper motions from Hipparcos vs. Tycho-2stat.fit.goodness;pos.pm;arith.difffloatnullablefmaxMaximum of F-measures reportedstat.fit.goodness;pos.pm;arith.difffloatnullablefkFK Part the star was found inmeta.refcharnullablegcStar Identifier in the GCmeta.id.crossintnullablet2Object is in Tycho-2meta.codebooleanhdStar Identifier in the HD-Cataloguemeta.id.crossintnullablehrStar Identifier in the HR-Cataloguemeta.id.crossintnullablecns4Star Identifier in CNS4meta.id.crosscharnullablefknoStar Identifier in the FKmeta.id.crossintnullablestar_nameName of the starmeta.idcharnullableccdmStar Identifier in the CCDM-Cataloguemeta.id.crosscharnullable
emiVLBI images of Lockman Hole radio sources These are 1.4GHz Very Long Baseline Interferometry images of 532 -radio sources with a flux density exceeding 100uJy as determined by -Ibar et al. (2009, MNRAS, 397, 281), obtained between 2010-06-03 and -2010-09-03. - -For all fields, we give frames processed using natural weighting to -preserve maximal sensitivity. For the 65 detected sources, we -additionally give frames processed using uniform weighting to suppress -sidelobes (see Middelberg et al. 2013, A&A 551, 97 for details) in -flux density measurements. Some sources have larger images to cover a -larger area because the initial coordinates were not sufficiently -accurate.emi.main These are 1.4GHz Very Long Baseline Interferometry images of 532 -radio sources with a flux density exceeding 100uJy as determined by -Ibar et al. (2009, MNRAS, 397, 281), obtained between 2010-06-03 and -2010-09-03. - -For all fields, we give frames processed using natural weighting to -preserve maximal sensitivity. For the 65 detected sources, we -additionally give frames processed using uniform weighting to suppress -sidelobes (see Middelberg et al. 2013, A&A 551, 97 for details) in -flux density measurements. Some sources have larger images to cover a -larger area because the initial coordinates were not sufficiently -accurate.561dataproduct_typeHigh level scientific classification of the data product, taken from an enumerationmeta.code.classobscore:obsdataset.dataproducttypecharnullabledataproduct_subtypeData product specific typemeta.code.classobscore:obsdataset.dataproductsubtypecharnullablecalib_levelAmount of data processing that has been applied to the datameta.code;obs.calibobscore:obsdataset.caliblevelshortobs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameSource name as in 2009MNRAS.397..281I (VizieR J/MNRAS/397/281)meta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_resolutionMinimal significant time interval along the time axisstime.resolutionobscore:char.timeaxis.resolution.refval.valuefloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablepol_statesList of polarization states in the data setmeta.code;phys.polarizationobscore:Char.PolarizationAxis.stateListcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullablet_xelNumber of elements (typically pixels) along the time axis.meta.numberobscore:Char.TimeAxis.numBinslongnullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullablepol_xelNumber of elements (typically pixels) along the polarization axis.meta.numberobscore:Char.PolarizationAxis.numBinslongnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullableem_ucdNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)meta.ucdobscore:Char.SpectralAxis.ucdcharnullablesource_tableName of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.meta.id;meta.tablecharnullableobsraAntenna pointing, RAdegpos.eq.rafloatnullableobsdecAntenna pointing, Decdegpos.eq.decfloatnullableweightingNatural or uniform, according to weighting method.meta.codecharnullables_resolution_minAngular resolution, longest baseline and max frequency dependentarcsecpos.angResolution;stat.minChar.SpatialAxis.Resolution.Bounds.Limits.LoLimfloatnullables_resolution_maxAngular resolution, longest baseline and min frequency dependentarcsecpos.angResolution;stat.maxChar.SpatialAxis.Resolution.Bounds.Limits.HiLimfloatnullable
ferosFEROS Public Spectra Spectra from FEROS spectrograph at La Silla's 1.5m telescope as -obtained during commissioning and guaranteed time.feros.data Spectra from FEROS spectrograph at La Silla's 1.5m telescope as -obtained during commissioning and guaranteed time.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullable
fk6The Sixth Fundamental Catalogue (FK6) Parts I and III of the sixth fundamental catalog, a catalog of -high-precision astrometry for bright stars combining centuries of -ground-based observations as reflected in FK5 with HIPPARCOS -astrometry. - -The result contains, in particular for the proper motions, -statistically significant improvements of the Hipparcos data und -represents a system of unprecedented accuracy for these 4150 -fundamental stars. The typical mean error in pm is 0.35 mas/year for -878 basic stars, and 0.59 mas/year for the sample of the 3272 -additional stars.fk6.fk6joinThe union of all published parts of FK6, comprising only the common -fields.4151localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharhipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortnoteNote for this objectmeta.notecharnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
fk6.part1Part I of the FK6 (successor to Basic FK5)878hipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubleindexeddej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoubleindexedpmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortlocalidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharindexedprimaryraltpRight ascension in LTP modedegpos.eq.radoublenullabledeltpDeclination in LTP modedegpos.eq.decdoublenullablepmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullableepraltpCentral epoch of RA (LTP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_raltpError in RA (LTP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdeltpCentral epoch of Dec (LTP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_deltpError in Dec (LTP)degstat.error;pos.eq.decfloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerastpRight ascension in STP modedegpos.eq.radoublenullabledestpDeclination in STP modedegpos.eq.decdoublenullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullableeprastpCentral epoch of RA (STP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rastpError in RA (STP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdestpCentral epoch of Dec (STP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_destpError in Dec (STP)degstat.error;pos.eq.decfloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablerahipRight ascension in HIP modedegpos.eq.radoublenullabledehipDeclination in HIP modedegpos.eq.decdoublenullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullableeprahipCentral epoch of RA (HIP)yrstat.error;time.epoch;pos.eq.rafloatnullablee_rahipError in RA (HIP) with cos(delta) already applieddegstat.error;pos.eq.rafloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullableepdehipCentral epoch of Dec (HIP)yrstat.error;time.epoch;pos.eq.decfloatnullablee_dehipError in Dec (HIP)degstat.error;pos.eq.decfloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxsiParallax obtained in solution SIdegpos.parallaxfloatnullablee_parallaxsiError in parallax obtained in solution SIdegstat.error;pos.parallaxfloatnullableparallaxstpParallax obtained in solution STPdegpos.parallaxfloatnullablee_parallaxstpError in parallax obtained in solution STPdegstat.error;pos.parallaxfloatnullableparallaxhipParallax obtained in solution HIPdegpos.parallaxfloatnullablee_parallaxhipError in parallax obtained in solution HIPdegstat.error;pos.parallaxfloatnullablenoteNote for this objectmeta.notecharnullable
fk6.part3Part III of the FK6 (containing stars from the FK5 extension and Rsup)3273localidFK6 number of the star (it is identical with its FK5 or FK4sup number)meta.id;meta.maincharsubsampleFlag for the subsample of FK6(III) stars; BX and FX denote stars from the bright and faint FK5 extensions, respectively, RS denotes stars from RSup (1993VeARI..34....1S)meta.id;meta.datasetcharnullablehipnoNumber of the star in the HIPPARCOS Catalogue (ESA 1997)meta.idintcomnameCommon Namemeta.idcharnullableraj2000The right ascension alpha of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.ra;meta.maindoubledej2000The declination delta of the star at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.degpos.eq.dec;meta.maindoublepmraThe proper-motion component of the star in alpha at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6, cos(delta) applied.deg/yrpos.pm;pos.eq.ra;meta.mainfloatpmdeThe proper-motion component mu_delta of the star in delta at epoch and equinox J2000.0 in the ICRS/HIPPARCOS system for the SI mode of the FK6.deg/yrpos.pm;pos.eq.dec;meta.mainfloatepraCentral epoch of raj2000 in the SI mode.yrtime.epoch;pos.eq.rafloate_raj2000Mean error of raj2000 in the SI mode, cos(delta) applied.degstat.error;pos.eq.ra;meta.mainfloate_pmraMean error of pmra in the SI mode.deg/yrstat.error;pos.pm;pos.eq.ra;meta.mainfloatepdeCentral epoch of delta in the SI mode.yrtime.epoch;pos.eq.decfloate_dej2000Mean error of dej2000 at the central epoch epdedegstat.error;pos.eq.ra;meta.mainfloate_pmdeMean error of pmde in the SI mode.deg/yrstat.error;pos.pm;pos.eq.dec;meta.mainfloatpres'Resulting' parallax p_res of the star. This is either the HIPPARCOS parallax or a photometric/spectroscopic parallax.degpos.parallaxfloatnullablee_presMean error of parallaxdegstat.error;pos.parallaxfloatnullablesrc_parSource of parallax (H=HIPPARCOS, P=Newly determined photometric or spectroscopic parallax)meta.code;pos.parallaxcharv_radRadial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablevmagApparent visual magnitude m_V of the star, taken from the HIPPARCOS Cataloguemagphot.mag;em.opt.VfloatvarflagFlag for the variability of the brightness of the star, taken from the HIPPARCOS Catalogue (see note)meta.code;src.varcharnullablek_binFlag for the double-star nature of the object (see note)meta.code.multipshortk_delta_muFlag for the double-star nature of the object based on differences between various proper motions (see note)meta.code.multipcharnullablek_aeFlag for astrometrically excellent stars, larger numbers are better (3 is best)meta.code.qualshortnullablesectFK6 part of this recordmeta.id.part;meta.mainshortpmraltpProper motion in RA, cos(delta) applied, in LTP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdeltpProper motion in Dec in LTP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmraltpMean error in PM(RA)*cos(delta) in LTP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeltpMean error in PM(Dec) in LTP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrastpProper motion in RA, cos(delta) applied, in STP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdestpProper motion in Dec in STP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrastpMean error in PM(RA)*cos(delta) in STP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdestpMean error in PM(Dec) in STP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmrahipProper motion in RA, cos(delta) applied, in HIP modedeg/yrpos.pm;pos.eq.rafloatnullablepmdehipProper motion in Dec in HIP modedeg/yrpos.pm;pos.eq.decfloatnullablee_pmrahipMean error in PM(RA)*cos(delta) in HIP modedeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdehipMean error in PM(Dec) in HIP modedeg/yrstat.error;pos.pm;pos.eq.decfloatnullablehipdupHIPPARCOS indicators for a suspected visual binary; d=duplicity induced variability (H52), s=Hipparcos suspected non-single (H61), t=bothmeta.code.multipcharnullablehipfitqualHIPPARCOS goodness-of-fit parameter (HIP Field H30, F2); A large value of F2 (e.g. larger than 3) may be caused by a duplicity of the object, but other reasons cannot be excluded. NULL means a negative goodness-of-fit in HIP.meta.code.qualshortnullablespeckleflagIndications on binarity provided by the catalogue of speckle observations (1999AJ....117.1890M); b=binarity resolved, u=possibly resolved, n=object observed but not resolvedmeta.code.multipcharnullableviscompIndicator for a star which has one (or more) visual component(s) with a separation rho of at least 60 arcsec.meta.code.multipcharnullablebinindsrvIndications for binarity provided by radial velocities from various sources (see Note)meta.code.multipcharnullablebinindeclIndicators for binarity from photometric variability (a=Algol-type, b=β Lyr-type, e=uncertain type, w=W UMa type)meta.code;src.varcharnullablepulsatingIndicator for a variability of the radial velocity V_rad due to stellar pulsation (which may be confused with a variability of V_rad due to spectroscopic binarity; c=Cepheid, s=δ Sct, b=β Cep)meta.code;src.varcharnullablenoteNote for this objectmeta.notecharnullable
flare_surveyPlates From Münster Flare Star Survey 1986-1991 From 1986 through 1991, the Astronomical Institute of Münster -University performed a search for flare stars in several southern -associations and open stellar clusters using the GPO telescope (d=40 -cm, WFPDB identifier ESO040); the fields suveyed include Coalsack, -M42, B228 Lup, the Chameleon T1 association, omicron Vel cluster, R -CrA association, the Pipe nebula (B59 Oph), and the Sco-Oph -association. This was done primarily through multiple exposures. The -files published here are plate scans done in 2017. - -The obscore collection name for these files is Muenster Flare Survey.flare_survey.data From 1986 through 1991, the Astronomical Institute of Münster -University performed a search for flare stars in several southern -associations and open stellar clusters using the GPO telescope (d=40 -cm, WFPDB identifier ESO040); the fields suveyed include Coalsack, -M42, B228 Lup, the Chameleon T1 association, omicron Vel cluster, R -CrA association, the Pipe nebula (B59 Oph), and the Sco-Oph -association. This was done primarily through multiple exposures. The -files published here are plate scans done in 2017. - -The obscore collection name for these files is Muenster Flare Survey.580accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablekindDirect observation, stellar tracks, or multiple exposure?meta.code;obscharnullableobjectName of the target object (mostly, cluster or association)meta.id;srccharindexednullableobs_durationTime between first shutter open and last shutter close (for multiply exposed plates, this is not the total exposure time)stime.interval;obs.exposurefloatnullabletotal_exptimeLength of exposure (non-contiguous for multiply exposed platesstime.duration;obs.exposurefloatnullableemulsionPhotographic emulsion used.instr.plate.emulsioncharnullablepub_didPublisher data set id; this is an identifier for the dataset in question and can be used to retrieve the data through, e.g., datalink.meta.id;meta.maincharnullabledatalink_urlURL to a datalink document for this plate (ancillary files, cutouts)meta.ref.urlcharnullablewfpdb_idPlate identifier as in the WFPDBmeta.idcharnullable
flashherosFlash/Heros Heidelberg spectra Spectra from the Flash and Heros Echelle spectrographs developed at -Landessternwarte Heidelberg and mounted at La Silla and various other -observatories. The data mostly contains spectra of OB stars. Heros was -the name of the instrument after Flash got a second channel in 1995.flashheros.dataFlash/Heros SSA table Spectra from the Flash and Heros Echelle spectrographs developed at -Landessternwarte Heidelberg and mounted at La Silla and various other -observatories. The data mostly contains spectra of OB stars. Heros was -the name of the instrument after Flash got a second channel in 1995.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablelocalkeyLocal observation key (used to connect to single orders).meta.idcharnullablessa_fluxcalibType of flux calibrationssa:Char.FluxAxis.Calibrationcharnullable
flashheros.ordersmetaSSA metadata for split-order Flash/Heros Echelle spectraaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.LengthintnullablelocalkeyLocal observation key.meta.idcharnullablen_ordersNumber of orders in the spectrum.meta.numberintnullableorder_minMinimal Echelle order in the spectrum.instr.order;stat.minintnullableorder_maxMaximal Echelle order in the spectrum.instr.order;stat.maxintnullable
fornaxDeep Mosaic of the Fornax cluster core This is a deep optical mosaic of the Fornax cluster’s core, covering -1.6 square degrees. The data were acquired with ESO/MPG 2.2m/WFI, -using a transparent filter that nearly equals the no-filter throughput -and thus provides a high signal-to-noise ratio. Based on an -approximate conversion to V-band magnitudes, the unbinned and binned -mosaics (0.24 and 0.71 arcsec/pixel) reach a median depth of 26.6 and -27.8 mag/sq.arcsec, respectively.fornax.data This is a deep optical mosaic of the Fornax cluster’s core, covering -1.6 square degrees. The data were acquired with ESO/MPG 2.2m/WFI, -using a transparent filter that nearly equals the no-filter throughput -and thus provides a high signal-to-noise ratio. Based on an -approximate conversion to V-band magnitudes, the unbinned and binned -mosaics (0.24 and 0.71 arcsec/pixel) reach a median depth of 26.6 and -27.8 mag/sq.arcsec, respectively.2accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullabledidGlobally unique IVOA publisher DID for this dataset.meta.idcharnullabledatalink_urlURL to a datalink document for this mosaic (ancillary files, cutouts)meta.ref.urlcharnullable
gaiaSelections from Gaia Data Release 3 (DR3) -This schema contains data re-published from the official -Gaia mirrors (such as ivo://uni-heidelberg.de/gaia/tap) either to -support combining its data with local tables (the various Xlite tables) -or to make the data more accessible to VO clients (e.g., epoch fluxes). - -Other Gaia-related data is found in, among others, the gdr3mock, -gdr3spec, gedr3auto, gedr3dist, gedr3mock, and gedr3spur schemas.gaia.dr2_ts_ssaGaia DR2 Timeseries SSA Table This table contains about 1.5 Million photometric timeseries for -roughly 0.5 Million objects. Photometry is available in the Gaia G, -BP, and RP bands for epochs between 2014-07-25 and 2016-05-25. The -spectra are available in VOTable format with the timeseries annotation -proposed in the Nadvornik et al IVOA note.1700000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxs**-1stat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxs**-1stat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullabletime_minFirst timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.mindoubleindexednullabletime_maxLast timestamp in time series (MJD Barycentric TCB)dtime.epoch;stat.maxdoubleindexednullable
gaia.dr2epochfluxGaia DR2 epoch fluxes -A table of the light curves released with Gaia DR2 (about half a million -in total). In each Gaia band (G, BP, RP), we give epochs, fluxes and -their errors in arrays. We do not include the quality flags (DR2: “may -be safely ignored for many general purpose applications”). You can -access them through the associated datalink service if you select -source_id. You will usually join this table with gaia.dr2light. - -We have also removed all entries with NaN observation times; hence, -the array lengths in the different bands can be significantly different, -and the indices in transit_ids do not always correspond to the -indices in the time series. - -Furthermore, we only give fluxes and their errors here rather than -magnitudes. Fluxes can be turned into magnitude using:: - - mag = -2.5 log10(flux)+zero point, - -where the zero points assumed for Gaia DR2 are -25.6884±0.0018 in G, 25.3514±0.0014 in BP, and -24.7619±0.0019 in RP (VEGAMAG).550737source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimarytransit_idTransit unique identifier. For a given object, a transit comprises the different Gaia observations (SM, AF, BP, RP and RVS) obtained for each focal plane crossing. NOTE: Where invalid observations have been removed, transit_id *cannot* be joined with times and fluxes.meta.versionlongnullableg_transit_timeThe field-of-view transit averaged observation times for the G-band observations. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullableg_transit_fluxG-band fluxes for the transit, for combination with g_transit_time_mjd. Here, this is a combination of individual SM-AF CCD fluxess**-1phot.flux;em.opt.Vfloatnullableg_transit_flux_errorThe error in G-band flux.s**-1stat.error;phot.flux;em.opt.Vfloatnullablerp_obs_timeThe observation time of the RP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablerp_fluxRP-band integrated fluxes, for combination with rp_obs_times**-1phot.flux;em.opt.Rfloatnullablerp_flux_errorThe error in RP-band flux.s**-1stat.error;phot.flux;em.opt.Rfloatnullablebp_obs_timeThe observation time of the BP CCD transit. This is given for barycentric TCB in JD-2,455,197.5.dtime.epochdoublenullablebp_fluxBP-band integrated fluxes, for combination with bp_obs_times**-1phot.flux;em.opt.Bfloatnullablebp_flux_errorThe error in BP-band flux.s**-1stat.error;phot.flux;em.opt.Bfloatnullablesolution_idA DPAC id for the toolchain used to produce these particular time series. It is given to facilitate comparison with ESAC data products.meta.versionlonggaia.dr2lightsource_idsource_id
gaia.dr2lightGaia DR2 source catalogue "light" -This is a “light” version of the full Gaia DR2 gaia_source table, -containing the original astrometric and photmetric columns with just -enough additional information to let careful researchers notice when data -is becomes uncertain and the full error model should be consulted. The -full DR2 is available from numerous places in the VO (in particular from -the TAP services ivo://uni-heidelberg.de/gaia/tap and -ivo://esavo/gaia/tap). - -This table also includes a column containing the Renormalized Unit Weight -Error RUWE (GAIA-C3-TN-LU-LL-124-01), a robust measure for the -consistency of the solution. - -On this TAP service, there is the table gdr2dist.main containing -distances computed by Bailer-Jones et al (:bibcode:`2018AJ....156...58B`). -If in doubt, use these instead of the parallaxes provided here.1600000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codefloatnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.dr3liteGaia DR3 source catalogue "light" This is gaia_source from the Gaia Data Release 3, stripped to just -enough columns to enable basic science (but therefore a bit faster and -simpler to deal with than the full gaia_source table). - -Note that on this server, there is also The gedr3dist.main, which -gives distances computed by Bailer-Jones et al. Use these in -preference to working with the raw parallaxes. - -This server also carries the gedr3mock schema containing a simulation -of gaia_source based on a state-of-the-art galaxy model, computed by -Rybizki et al. - -The full DR3 is available from numerous places in the VO (in -particular from the TAP services ivo://uni-heidelberg.de/gaia/tap and -ivo://esavo/gaia/tap).1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gaia.edr3liteGaia eDR3 source catalogue "light" This is a “light” version of the full Gaia DR3 gaia_source table. It -is just a view copying gaia.dr3lite, which should preferentially be -used in new queries. This table is being kept around in order to keep -legacy queries from breaking unnecessarily. However, it is actually -DR3 data rather than eDR3. The minute differences did not seem to -warrant keeping two copies of the relatively massive data around.1811709771source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullable
gcnsThe Gaia eDR3 Catalogue of Nearby Stars GCNS -This is a clean and well characterised catalogue of objects within 100pc of -the Sun from the Gaia early third data release. We characterise the -catalogue using the full data release, and comparisons to other catalogues -in literature and simulations. For all candidates (measured parallax < -8 mas), we calculate a distance probability function using Bayesian -procedures and mock catalogues for the prediction of the priors. For each -entry using a random forest classifier we attempt to remove sources with -spurious astrometric solutions. - -This results in 331312 objects that should contain at least 92% of stars -within 100 pc at spectral type M9. - -GCNS comes with several auxiliary tables, in particular lists of -resolved stellar systems, of known neary stars not found in eDR3 and -of candidates of Hyades and ComaBer cluster members.gcns.hyacobeDR3 GCNS open cluster membership table A list of 920+212 probable Hyades and ComaBer members in the eDR3 -GCNS sample.1132source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullablenameName of the cluster this object probably belongs tometa.idcharnullablec_clusterDimensionless chi-square test statistic. Small values indicate highly probable members (cf. eq. 4 in 2018MNRAS.477.3197R)stat.likelihoodfloatnullabledist_clusterDistance of each star from the cluster barycentre.pcpos.distancefloatnullablegcns.mainsource_idsource_id
gcns.maglims5Magnitude distribution over 5-HEALPixes The G magnitude distribution percentiles per level 5 HEALpixes for -all Gaia sources with a parallax and a G magnitude measurement. Can be -used to approximate the G magnitude limit for Gaia at that position of -the sky. Sources up to a limiting magnitude equal to 'magnitude_70' -are 98% complete when compared to PS1. The 80th and 90th percentile -decrease the completeness in Gaia to 97% and 95%, respectively. These -cuts can be very useful, when trying to compare Gaia data to models, -e.g. the GeDR3mock catalog (gedrmock.main).12288hpxHEALPix on level 5 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcns.maglims6Magnitude distribution over 6-HEALPixes The G magnitude distribution percentiles per level 6 HEALpixes for -all Gaia sources with a parallax and a G magnitude measurement. Can be -used to approximate the G magnitude limit for Gaia at that position of -the sky. Sources up to a limiting magnitude equal to 'magnitude_70' -are 98% complete when compared to PS1. The 80th and 90th percentile -decrease the completeness in Gaia to 97% and 95%, respectively. These -cuts can be very useful, when trying to compare Gaia data to models, -e.g. the GeDR3mock catalog (gedrmock.main).49152hpxHEALPix on level 6 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcns.maglims7Magnitude distribution over 7-HEALPixes The G magnitude distribution percentiles per level 7 HEALpixes for -all Gaia sources with a parallax and a G magnitude measurement. Can be -used to approximate the G magnitude limit for Gaia at that position of -the sky. Sources up to a limiting magnitude equal to 'magnitude_70' -are 98% complete when compared to PS1. The 80th and 90th percentile -decrease the completeness in Gaia to 97% and 95%, respectively. These -cuts can be very useful, when trying to compare Gaia data to models, -e.g. the GeDR3mock catalog (gedrmock.main).196608hpxHEALPix on level 7 these statistics are forpos.healpixfloatnullablemagnitude_7070th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_8080th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablemagnitude_9090th percentle of the G-magnitude distribution in Gaia eDR3 for all objects with both parallax and a G magnitudemagstat.paramfloatnullablesourcecountNumber of objects contributing to the distributionmeta.numberint
gcns.maineDR3 Gaia Catalogue of Nearby Stars (GCNS)This is the main catalogue. Additional resources include: -gcns.resolvedss (resolved stellar systems), gcns.missing_10mas -(objects missing from eDR3 that have been suspected of being within -100 pc before), and gcns.hyacob (probable members of the Hyades and -the Coma Berenices open cluster).331312source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.missing_10maseDR3 GCNS list of possibly nearby stars missingA table of 1258 objects with published parallaxes greater than 10mas -that are not or have no parallax in Gaia eDR3 and are hence not listed -in gcns.main.1259main_idSource name from Simbadmeta.id;meta.maincharnullableraICRS RA from Simbaddegpos.eq.ra;meta.maindoubleindexednullabledecICRS Dec from Simbaddegpos.eq.dec;meta.maindoubleindexednullableplx_valueParallax from Simbadmaspos.parallaxfloatnullableplx_bibcodeSource reference for the parallaxmeta.bib.bibcodecharnullableotypeSimbad object typemeta.code.classcharnullable
gcns.rejectedeDR3 GCNS: Rejected ObjectsThis is the catalogue of objects in the 8mas sample that were rejected -for the main Gaia Catalogue of Nearby Stars as having a zero -probability of being inside 100pc or indicated as a spurious -astrometric solution.source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryraICRS right ascension from Gaia eDR3.degpos.eq.ra;meta.maindoubleindexednullabledecICRS declination from Gaia eDR3.degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullableipd_frac_multi_peakPercentage of distance windows in which a double peak was seen (high values mean high likelihood of a resolved double star).meta.code.multipshortadoptedrvAdopted Radial Velocitykm/sphys.veloc;pos.heliocentricfloatnullableadoptedrv_errorError in adopted RVkm/sstat.error;phys.veloc;pos.heliocentricfloatnullableadoptedrv_refnameBibcode for the source of the radial velocitymeta.bib.bibcodecharnullableradial_velocity_is_valid1 if this object has a radial velocity in eDR3, 0 otherwisemeta.code.qualshortgcns_probProbability that the astrometry is reliablestat.fit.goodnessfloatnullablewd_probprobability that this is a white dwarf.stat.likelihood;src.classfloatnullabledist_11st percentile of the distance PDF, used in GCNS selectionkpcstat.value;pos.distancefloatnullabledist_1616th percentile of the distance PDF (1 σ lower bound)kpcstat.value;pos.distancefloatnullabledist_50Median of the distance PDFkpcpos.distance;stat.medianfloatnullabledist_8484th percentile of the distance PDF (1 σ upper bound)kpcstat.value;pos.distancefloatnullablexcoord_50Median x coordinate in the Galactic frame assuming dist_50pcpos.cartesian.x;stat.medianfloatnullablexcoord_161 σ lower bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullablexcoord_841 σ upper bound of Galactic frame x coordinatepcstat.value;pos.cartesian.xfloatnullableycoord_50Median y coordinate in the Galactic frame assuming dist_50pcpos.cartesian.y;stat.medianfloatnullableycoord_161 σ lower bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullableycoord_841 σ upper bound of Galactic frame y coordinatepcstat.value;pos.cartesian.yfloatnullablezcoord_50Median z coordinate in the Galactic frame assuming dist_50pcpos.cartesian.z;stat.medianfloatnullablezcoord_161 σ lower bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullablezcoord_841 σ upper bound of Galactic frame z coordinatepcstat.value;pos.cartesian.zfloatnullableuvel_50Median velocity u in the Galactic frame, direction positive xkm/sphys.veloc;pos.cartesian.x;stat.medianfloatnullableuvel_161 σ lower bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullableuvel_841 σ upper bound for ukm/sstat.value;phys.veloc;pos.cartesian.xfloatnullablevvel_50Median velocity v in the Galactic frame, direction positive ykm/sphys.veloc;pos.cartesian.y;stat.medianfloatnullablevvel_161 σ lower bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablevvel_841 σ upper bound for vkm/sstat.value;phys.veloc;pos.cartesian.yfloatnullablewvel_50Median velocity w in the Galactic frame, direction positive zkm/sphys.veloc;pos.cartesian.z;stat.medianfloatnullablewvel_161 σ lower bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablewvel_841 σ upper bound for wkm/sstat.value;phys.veloc;pos.cartesian.zfloatnullablename_gunnObject Name from PanSTARRS/SDSS/SkyMapper surveymeta.id.crosscharnullablerefname_gunnReference for the source of the Gunn photometrymeta.bib.bibcodecharnullablegmag_gunnGunn G band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Vfloatnullablee_gmag_gunnUncertainty in G band magnitudemagstat.error;phot.mag;em.opt.Vfloatnullablermag_gunnGunn R band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Rfloatnullablee_rmag_gunnUncertainty in R band magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableimag_gunnGunn I band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_imag_gunnUncertainty in I band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablezmag_gunnGunn Z band magnitude (when from SDSS, g, when from Skymapper, g_psf)magphot.mag;em.opt.Ifloatnullablee_zmag_gunnUncertainty in Z band magnitudemagstat.error;phot.mag;em.opt.Ifloatnullablename_2massName of this object in 2MASSmeta.id.crosscharnullablej_m_2mass2MASS J band magnitudemagphot.mag;em.IR.Jfloatnullablej_msig_2massUncertainty in 2MASS J band magnitudemagstat.error;phot.mag;em.IR.Jfloatnullableh_m_2mass2MASS H band magnitudemagphot.mag;em.IR.Hfloatnullableh_msig_2massUncertainty in 2MASS H band magnitudemagstat.error;phot.mag;em.IR.Hfloatnullablek_m_2mass2MASS K band magnitudemagphot.mag;em.IR.Kfloatnullablek_msig_2massUncertainty in 2MASS K band magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablename_wiseName of this object in WISEmeta.id.crosscharnullablew1mpro_pm_wiseCATWISE W1 band magnitudemagphot.mag;em.IR.3-4umfloatnullablew1sigmpro_pm_wiseUncertainty in CATWISE W1 band magnitudemagstat.error;phot.mag;em.IR.3-4umfloatnullablew2mpro_pm_wiseCATWISE W2 band magnitudemagphot.mag;em.IR.4-8umfloatnullablew2sigmpro_pm_wiseUncertainty in CATWISE W2 band magnitudemagstat.error;phot.mag;em.IR.4-8umfloatnullablew3mpro_wiseCATWISE W3 band magnitudemagphot.mag;em.IR.8-15umfloatnullablew3sigmpro_wiseUncertainty in CATWISE W3 band magnitudemagstat.error;phot.mag;em.IR.8-15umfloatnullablew4mpro_wiseALLWISE W4 band magnitudemagphot.mag;em.IR.15-30umfloatnullablew4sigmpro_wiseUncertainty in ALLWISE W4 band magnitudemagstat.error;phot.mag;em.IR.15-30umfloatnullable
gcns.resolvedsseDR3 GCNS Resolved Binary Candidates -Resolved binary candidates in the GCNS catalogue as discussed in -https://doi.org/10.1051/0004-6361/202039498, “stellar multiplicity: -resolved systems”. You probably want to join this table to gaia.edr3lite -using source_id1 and/or source_id2.19176source_id1Gaia EDR3 source_id of the primary starmeta.id.partlongsource_id2Gaia EDR3 source_id of secondary startmeta.id.partlongseparationAngular separation of the two sources.arcsecpos.angDistancefloatnullablemag_diffG magnitude difference between the two componentsmagphot.mag;arith.diff;em.opt.Vfloatnullableproj_sepProjected separation of the pairAUphys.sizefloatnullablebin1 if the system is probably made up of more than two stars, 0 otherwise.meta.code.multipshortbound1 if the system is probably gravitationally bound, 0 otherwisemeta.codeshort
gcpmsStellar Proper Motions in the Ogle II Galactic Bulge FieldsA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic -bulge (GB) fields, covering a range of -11°<l<11° and -6°<b<3°. Some -columns have been left out from the original source.gcpms.dataA proper-motion catalogue of 5080236 stars in 49 OGLE-II Galactic -bulge (GB) fields, covering a range of -11°<l<11° and -6°<b<3°. Some -columns have been left out from the original source.5100000fieldOGLE field numbermeta.id;obs.fieldshortogleOGLE numbermeta.id;meta.mainintnpointNumber of data pointsmeta.number;stat.fitshortpmraProper motion in right ascension (mu(RA)cos(DE)deg/yrpos.pm;pos.eq.rafloatnullablee_pmrarms uncertainty on pmRAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in declination (mu(DE))deg/yrpos.pm;pos.eq.decfloatnullablee_pmderms uncertainty on pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullabledrefcDifferential refraction coefficientdegfloatnullablesdevStandard deviation of data points in the fittingdegstat.stdev;posfloatnullableimagI magnitudemagphot.mag;em.opt.Ifloatnullablev_iV-I colour indexmagphot.color;em.opt.V;em.opt.Ifloatnullableraj2000Right ascension in decimal degrees (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination in decimal degrees (J2000)degpos.eq.dec;meta.maindoubleindexednullablexposx pixel coordinate in template imagepixpos.cartesian.x;instr.detfloatnullableyposy pixel coordinate in template imagepixpos.cartesian.y;instr.detfloatnullable
gdr2apAstrophysical parameters from Gaia DR2, 2MASS and AllWise We estimated the stellar astrophysical parameters of 120 million -stars over the entire sky that have Gaia parallax and photometry from -Gaia DR2, 2MASS, and AllWISE. We provide estimates of log age, log -mass, log temperature, log luminosity, log surface gravity, distance -modulus, dust extinction (A0), and average grain size (R0) along the -lines of sight. In contrast with other catalogs, we do not use a -Galactic model as prior but weakly informative ones. Our estimate and -uncertainties are quantiles, so they are invariant under monotonic -transformations (e.g., log, exp). This means that one can use our -median estimate to obtain the median distance or temperature, for -instance, and likewise for the uncertainties.gdr2ap.main We estimated the stellar astrophysical parameters of 120 million -stars over the entire sky that have Gaia parallax and photometry from -Gaia DR2, 2MASS, and AllWISE. We provide estimates of log age, log -mass, log temperature, log luminosity, log surface gravity, distance -modulus, dust extinction (A0), and average grain size (R0) along the -lines of sight. In contrast with other catalogs, we do not use a -Galactic model as prior but weakly informative ones. Our estimate and -uncertainties are quantiles, so they are invariant under monotonic -transformations (e.g., log, exp). This means that one can use our -median estimate to obtain the median distance or temperature, for -instance, and likewise for the uncertainties.130000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimarya0_bestmultivariate maximum posterior estimate for the dust exctinction A₀ towards this source.magphys.absorptionfloatnullablea0_p50median of the distribution of dust exctinction A₀ towards this source.magphys.absorption;stat.medianfloatindexednullablea0_distDistribution (min, p16, p25, p50, p75, p84, max) of the dust exctinction A₀ towards this source. In ADQL, write a0_dist[1] for the minimum, a0_dist[2] for the 16th percentile, and so on.magstat;phys.absorptionfloatnullabler0_bestmultivariate maximum posterior estimate for the average dust grain size extinction parameter.phys.absorptionfloatnullabler0_p50median of the distribution of average dust grain size extinction parameter.phys.absorption;stat.medianfloatindexednullabler0_distDistribution (min, p16, p25, p50, p75, p84, max) of the average dust grain size extinction parameter. In ADQL, write r0_dist[1] for the minimum, r0_dist[2] for the 16th percentile, and so on.stat;phys.absorptionfloatnullableloga_bestmultivariate maximum posterior estimate for the log10 of the age.log(yr)time.agefloatnullableloga_p50median of the distribution of log10 of the age.log(yr)time.age;stat.medianfloatnullableloga_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the age. In ADQL, write loga_dist[1] for the minimum, loga_dist[2] for the 16th percentile, and so on.log(yr)stat;time.agefloatnullablelogl_bestmultivariate maximum posterior estimate for the log10 of the luminosity.log(solLum)phys.luminosityfloatnullablelogl_p50median of the distribution of log10 of the luminosity.log(solLum)phys.luminosity;stat.medianfloatindexednullablelogl_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the luminosity. In ADQL, write logl_dist[1] for the minimum, logl_dist[2] for the 16th percentile, and so on.log(solLum)stat;phys.luminosityfloatnullablelogm_bestmultivariate maximum posterior estimate for the log10 of the mass.log(solMass)phys.massfloatnullablelogm_p50median of the distribution of log10 of the mass.log(solMass)phys.mass;stat.medianfloatnullablelogm_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the mass. In ADQL, write logm_dist[1] for the minimum, logm_dist[2] for the 16th percentile, and so on.log(solMass)stat;phys.massfloatnullablelogt_bestmultivariate maximum posterior estimate for the log10 of the effective temperature.log(K)phys.temperaturefloatnullablelogt_p50median of the distribution of log10 of the effective temperature.log(K)phys.temperature;stat.medianfloatindexednullablelogt_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the effective temperature. In ADQL, write logt_dist[1] for the minimum, logt_dist[2] for the 16th percentile, and so on.log(K)stat;phys.temperaturefloatnullablelogg_bestmultivariate maximum posterior estimate for the log10 of the surface gravity.log(cm/s**2)phys.gravityfloatnullablelogg_p50median of the distribution of log10 of the surface gravity.log(cm/s**2)phys.gravity;stat.medianfloatnullablelogg_distDistribution (min, p16, p25, p50, p75, p84, max) of the log10 of the surface gravity. In ADQL, write logg_dist[1] for the minimum, logg_dist[2] for the 16th percentile, and so on.log(cm/s**2)stat;phys.gravityfloatnullablea_bp_bestmultivariate maximum posterior estimate for the attenuation in the Gaia BP band towards this source..magphys.absorption;em.opt.Bfloatnullablea_bp_p50median of the distribution of attenuation in the Gaia BP band towards this source..magphys.absorption;em.opt.B;stat.medianfloatnullablea_bp_distDistribution (min, p16, p25, p50, p75, p84, max) of the attenuation in the Gaia BP band towards this source.. In ADQL, write a_bp_dist[1] for the minimum, a_bp_dist[2] for the 16th percentile, and so on.magstat;phys.absorption;em.opt.Bfloatnullablea_g_bestmultivariate maximum posterior estimate for the attenuation in the Gaia G band towards this source..magphys.absorption;em.optfloatnullablea_g_p50median of the distribution of attenuation in the Gaia G band towards this source..magphys.absorption;em.opt;stat.medianfloatnullablea_g_distDistribution (min, p16, p25, p50, p75, p84, max) of the attenuation in the Gaia G band towards this source.. In ADQL, write a_g_dist[1] for the minimum, a_g_dist[2] for the 16th percentile, and so on.magstat;phys.absorption;em.optfloatnullablea_rp_bestmultivariate maximum posterior estimate for the attenuation in the Gaia RP band towards this source..magphys.absorptionfloatnullablea_rp_p50median of the distribution of attenuation in the Gaia RP band towards this source..magphys.absorption;stat.medianfloatnullablea_rp_distDistribution (min, p16, p25, p50, p75, p84, max) of the attenuation in the Gaia RP band towards this source.. In ADQL, write a_rp_dist[1] for the minimum, a_rp_dist[2] for the 16th percentile, and so on.magstat;phys.absorptionfloatnullablemag_bpRecalibrated Gaia BP magnitude.magphot.mag;em.opt.Bfloatnullableerr_bpRecalibrated error from original Gaia BP magnitude.magstat.error;phot.mag;em.opt.Bfloatnullablebp_bestmultivariate maximum posterior estimate for the Gaia BP magnitude.magphot.mag;em.opt.Bfloatnullablebp_p50median of the distribution of Gaia BP magnitude.magphot.mag;em.opt.B;stat.medianfloatnullablebp_distDistribution (min, p16, p25, p50, p75, p84, max) of the Gaia BP magnitude. In ADQL, write bp_dist[1] for the minimum, bp_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.opt.Bfloatnullablemag_gRecalibrated Gaia G magnitude.magphot.mag;em.optfloatnullableerr_gRecalibrated error from original Gaia G magnitude.magstat.error;phot.mag;em.optfloatnullableg_bestmultivariate maximum posterior estimate for the Gaia G magnitude.magphot.mag;em.optfloatnullableg_p50median of the distribution of Gaia G magnitude.magphot.mag;em.opt;stat.medianfloatnullableg_distDistribution (min, p16, p25, p50, p75, p84, max) of the Gaia G magnitude. In ADQL, write g_dist[1] for the minimum, g_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.optfloatnullablemag_rpRecalibrated Gaia RP magnitude.magphot.mag;em.opt.Rfloatnullableerr_rpRecalibrated error from original Gaia RP magnitude.magstat.error;phot.mag;em.opt.Rfloatnullablerp_bestmultivariate maximum posterior estimate for the Gaia RP magnitude.magphot.mag;em.opt.Rfloatnullablerp_p50median of the distribution of Gaia RP magnitude.magphot.mag;em.opt.R;stat.medianfloatnullablerp_distDistribution (min, p16, p25, p50, p75, p84, max) of the Gaia RP magnitude. In ADQL, write rp_dist[1] for the minimum, rp_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.opt.Rfloatnullablemag_jRecalibrated 2MASS J magnitude.magphot.mag;em.IR.Jfloatnullableerr_jRecalibrated error from original 2MASS J magnitude.magstat.error;phot.mag;em.IR.Jfloatnullablej_bestmultivariate maximum posterior estimate for the 2MASS J magnitude.magphot.mag;em.IR.Jfloatnullablej_p50median of the distribution of 2MASS J magnitude.magphot.mag;em.IR.J;stat.medianfloatnullablej_distDistribution (min, p16, p25, p50, p75, p84, max) of the 2MASS J magnitude. In ADQL, write j_dist[1] for the minimum, j_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.Jfloatnullablemag_hRecalibrated 2MASS H magnitude.magphot.mag;em.IR.Hfloatnullableerr_hRecalibrated error from original 2MASS H magnitude.magstat.error;phot.mag;em.IR.Hfloatnullableh_bestmultivariate maximum posterior estimate for the 2MASS H magnitude.magphot.mag;em.IR.Hfloatnullableh_p50median of the distribution of 2MASS H magnitude.magphot.mag;em.IR.H;stat.medianfloatnullableh_distDistribution (min, p16, p25, p50, p75, p84, max) of the 2MASS H magnitude. In ADQL, write h_dist[1] for the minimum, h_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.Hfloatnullablemag_ksRecalibrated 2MASS Ks magnitude.magphot.mag;em.IR.Kfloatnullableerr_ksRecalibrated error from original 2MASS Ks magnitude.magstat.error;phot.mag;em.IR.Kfloatnullableks_bestmultivariate maximum posterior estimate for the 2MASS Ks magnitude.magphot.mag;em.IR.Kfloatnullableks_p50median of the distribution of 2MASS Ks magnitude.magphot.mag;em.IR.K;stat.medianfloatnullableks_distDistribution (min, p16, p25, p50, p75, p84, max) of the 2MASS Ks magnitude. In ADQL, write ks_dist[1] for the minimum, ks_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.Kfloatnullablemag_w1Recalibrated WISE W1 magnitude.magphot.mag;em.IR.3-4umfloatnullableerr_w1Recalibrated error from original WISE W1 magnitude.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1_bestmultivariate maximum posterior estimate for the WISE W1 magnitude.magphot.mag;em.IR.3-4umfloatnullablew1_p50median of the distribution of WISE W1 magnitude.magphot.mag;em.IR.3-4um;stat.medianfloatnullablew1_distDistribution (min, p16, p25, p50, p75, p84, max) of the WISE W1 magnitude. In ADQL, write w1_dist[1] for the minimum, w1_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.3-4umfloatnullablemag_w2Recalibrated WISE W2 magnitude.magphot.mag;em.IR.4-8umfloatnullableerr_w2Recalibrated error from original WISE W2 magnitude.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2_bestmultivariate maximum posterior estimate for the WISE W2 magnitude.magphot.mag;em.IR.4-8umfloatnullablew2_p50median of the distribution of WISE W2 magnitude.magphot.mag;em.IR.4-8um;stat.medianfloatnullablew2_distDistribution (min, p16, p25, p50, p75, p84, max) of the WISE W2 magnitude. In ADQL, write w2_dist[1] for the minimum, w2_dist[2] for the 16th percentile, and so on.magstat;phot.mag;em.IR.4-8umfloatnullabledmod_bestmultivariate maximum posterior estimate for the distance modulus.magphot.mag.distModfloatnullabledmod_p50median of the distribution of distance modulus.magphot.mag.distMod;stat.medianfloatnullabledmod_distDistribution (min, p16, p25, p50, p75, p84, max) of the distance modulus. In ADQL, write dmod_dist[1] for the minimum, dmod_dist[2] for the 16th percentile, and so on.magstat;phot.mag.distModfloatnullablelnlike_bestmultivariate maximum posterior estimate for the log likelihood of the solution (paper Eq. 1).stat.paramfloatnullablelnlike_p50median of the distribution of log likelihood of the solution (paper Eq. 1).stat.param;stat.medianfloatnullablelnlike_distDistribution (min, p16, p25, p50, p75, p84, max) of the log likelihood of the solution (paper Eq. 1). In ADQL, write lnlike_dist[1] for the minimum, lnlike_dist[2] for the 16th percentile, and so on.stat;stat.paramfloatnullablelnp_bestmultivariate maximum posterior estimate for the log posterior of the solution (paper Eq. 2).stat.probabilityfloatnullablelnp_p50median of the distribution of log posterior of the solution (paper Eq. 2).stat.probability;stat.medianfloatnullablelnp_distDistribution (min, p16, p25, p50, p75, p84, max) of the log posterior of the solution (paper Eq. 2). In ADQL, write lnp_dist[1] for the minimum, lnp_dist[2] for the 16th percentile, and so on.stat;stat.probabilityfloatnullablelog10jitter_bestmultivariate maximum posterior estimate for the log photometric likelihood jitter common to all bands.log(mag)stat.paramfloatnullablelog10jitter_p50median of the distribution of log photometric likelihood jitter common to all bands.log(mag)stat.param;stat.medianfloatnullablelog10jitter_distDistribution (min, p16, p25, p50, p75, p84, max) of the log photometric likelihood jitter common to all bands. In ADQL, write log10jitter_dist[1] for the minimum, log10jitter_dist[2] for the 16th percentile, and so on.log(mag)stat;stat.paramfloatnullableparallaxRecalibrated parallax.maspos.parallaxfloatnullableerr_parallaxError in recalibrated parallax.masstat.error;pos.parallaxfloatnullable
gdr2distEstimated distances to 1.33 billion stars in Gaia DR2 -This catalogue provides distances estimates (and uncertainties therein) -for 1.33 billion stars over the whole sky brighter than about G=20.7. -These have been estimated using the parallaxes (and their uncertainties) -from Gaia DR2. A Bayesian procedure was used involving a prior -with a single parameter L(l,b), which varies smoothly with Galactic -longitude and latitude according to a Galaxy model. The posterior is -summarized with a point estimate (usually the mode) and a confidence -interval (usually the 68% highest density interval). The estimation -procedure is described in detail in the `accompanying paper`_, -which also analyses the catalogue content. - -.. _accompanying paper: http://www.mpia.de/homes/calj/gdr2_distances.htmlgdr2dist.main -This catalogue provides distances estimates (and uncertainties therein) -for 1.33 billion stars over the whole sky brighter than about G=20.7. -These have been estimated using the parallaxes (and their uncertainties) -from Gaia DR2. A Bayesian procedure was used involving a prior -with a single parameter L(l,b), which varies smoothly with Galactic -longitude and latitude according to a Galaxy model. The posterior is -summarized with a point estimate (usually the mode) and a confidence -interval (usually the 68% highest density interval). The estimation -procedure is described in detail in the `accompanying paper`_, -which also analyses the catalogue content. - -.. _accompanying paper: http://www.mpia.de/homes/calj/gdr2_distances.html1400000000source_idUnique source identifier. Note that this *cannot* be matched against the DR1 source_id.meta.id;meta.mainlongindexedprimaryr_estEstimated distancepcpos.distancefloatindexednullabler_loLower bound on the 1 σ confidence intervalpcpos.distance;stat.minfloatnullabler_hiUpper bound on the 1 σ confidence intervalpcpos.distance;stat.maxfloatnullabler_lenLength scale used in the prior for the distance estimation.pcstat.fit.param;pos.distancefloatnullableresult_flagType of result.meta.code.qualshortmodality_flagResult regime flag: number of modes in the posterior (1 or 2).meta.codeshort
gdr2mockA Gaia DR2 mock stellar catalog This catalogue is a simulation of the Gaia DR2 stellar content using -Galaxia (a tool to sample stars from a Besancon-like Milky Way model), -3d dust extinction maps and the latest PARSEC Isochrones. It is -mimicking the Gaia DR2 data model and an apparent magnitude limit of -g=20,7. Extinctions and photometry in different bands have also been -included in a supplementary table as well as uncertainty estimates -using a scaled nominal error model.gdr2mock.mainA synthetic Milky Way catalog mimicking GDR2 in stellar content and -data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoubleindexednullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoubleindexednullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_magApproximate estimate for the RVS magnitude. This uses formulae (2) and (3) from 2018A&A...616A...1G. Outside of the range 0.1<BP-G<1.7 we use Eq. 3 (which means the value is probably fairly bogus).magphot.color;em.opt.Ifloatnullablerv_nb_transitsNumber of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epochReference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_qHipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noiseExcess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sigSignificance of excess noisestat.valuefloatnullableastrometric_n_obs_acTotal number of observations ACmeta.numbershortastrometric_n_obs_alTotal number of observations ALmeta.numbershortastrometric_n_bad_obs_acNumber of bad observations ACmeta.numbershortastrometric_n_bad_obs_alNumber of bad observations ALmeta.numbershortastrometric_n_good_obs_acNumber of good observations ACmeta.numbershortastrometric_n_good_obs_alNumber of good observations ALmeta.numbershortastrometric_chi2_alAstrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flagOnly primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colourColour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_alMean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisiblilty_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_maxThe longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observationsThe number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_usedType of prior used in in the astrometric solutionshortnullableastrometric_relegation_factorRelegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_acMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_alMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_sourceDuring data processing, this source happened to have been duplicated and one source only has been kept.shortra_dec_corrCorrelation between right ascension and declinationstat.correlationfloatnullablera_pmra_corrCorrelation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corrCorrelation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corrCorrelation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corrCorrelation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corrCorrelation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corrCorrelation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corrCorrelation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corrCorrelation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corrCorrelation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4Degree of concentration of scan directions across the sourcefloatnullablepriam_flagsFlags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flagsFlags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lowerLower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upperUpper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lowerLower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upperUpper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lowerLower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upperUpper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lowerLower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upperUpper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lowerLower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upperUpper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefehFe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullablemassInitial mass of the starsolMassphys.massfloatnullableageAge of the starGyrtime.agefloatnullableloggLogarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablenobsNominal number of observations, scaled to the shorter time base of GDR2 (a function with ecliptic latitude).meta.number;obsintindex_parsecForeign key into the photometry/extinction table.meta.id.crossintgdr2mock.photometryindex_parsecindex_parsec
gdr2mock.photometryPhotometry for the Gaia DR2 mock catalogThis table contains simulated absolute magnitudes to about 0.1 mag -precision for all the stars, as well as extinctions in several bands; -To use it, join it USING (parsec_index) with the gdr2mock.main table.mag_gaia_gSimulated absolute magnitude in the Gaia G band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_uSimulated absolute magnitude in the Johnson U band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_ubv_bSimulated absolute magnitude in the Johnson B band (note that no extinction is applied).magphot.mag;em.opt.Bfloatnullablemag_ubv_vSimulated absolute magnitude in the Johnson V band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_ubv_rSimulated absolute magnitude in the Johnson R band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_ubv_iSimulated absolute magnitude in the Johnson I band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_ubv_jSimulated absolute magnitude in the Johnson J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_ubv_hSimulated absolute magnitude in the Johnson H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_ubv_kSimulated absolute magnitude in the Johnson K band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_sdss_uSimulated absolute magnitude in the SDSS u band (note that no extinction is applied).magphot.mag;em.opt.Ufloatnullablemag_sdss_gSimulated absolute magnitude in the SDSS g band (note that no extinction is applied).magphot.mag;em.opt.Vfloatnullablemag_sdss_rSimulated absolute magnitude in the SDSS r band (note that no extinction is applied).magphot.mag;em.opt.Rfloatnullablemag_sdss_iSimulated absolute magnitude in the SDSS i band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_sdss_zSimulated absolute magnitude in the SDSS z band (note that no extinction is applied).magphot.mag;em.opt.Ifloatnullablemag_2mass_jSimulated absolute magnitude in the 2MASS J band (note that no extinction is applied).magphot.mag;em.ir.Jfloatnullablemag_2mass_hSimulated absolute magnitude in the 2MASS H band (note that no extinction is applied).magphot.mag;em.ir.Hfloatnullablemag_2mass_ksSimulated absolute magnitude in the 2MASS K' band (note that no extinction is applied).magphot.mag;em.ir.Kfloatnullablemag_wise_w1Simulated absolute magnitude in the WISE W1 band (note that no extinction is applied).magphot.mag;em.ir.3-4umfloatnullablemag_wise_w2Simulated absolute magnitude in the WISE W2 band (note that no extinction is applied).magphot.mag;em.ir.4-8umfloatnullablemag_wise_w3Simulated absolute magnitude in the WISE W3 band (note that no extinction is applied).magphot.mag;em.ir.8-15umfloatnullablemag_wise_w4Simulated absolute magnitude in the WISE W4 band (note that no extinction is applied).magphot.mag;em.ir.15-30umfloatnullableindex_parsecThe parsec bin has the format AABBCCCDDD, where AA denotes the metallicity bin, BB the luminosity bin, CCC the T_eff bin, and DDD the extinction bin.meta.id;meta.maininta_bpExtinction in the Gaia BP bandmagphys.absorption;em.opt.Bfloatnullablea_rpExtinction in the Gaia RP bandmagphys.absorption;em.opt.Rfloatnullablea_juExtinction in the Johnson U bandmagphys.absorption;em.opt.Ufloatnullablea_jbExtinction in the Johnson B bandmagphys.absorption;em.opt.Bfloatnullablea_jvExtinction in the Johnson V bandmagphys.absorption;em.opt.Vfloatnullablea_jrExtinction in the Johnson R bandmagphys.absorption;em.opt.Rfloatnullablea_jiExtinction in the Johnson I bandmagphys.absorption;em.opt.Ifloatnullablea_jjExtinction in the Johnson J bandmagphys.absorption;em.ir.Jfloatnullablea_jhExtinction in the Johnson H bandmagphys.absorption;em.ir.Hfloatnullablea_jkExtinction in the Johnson K bandmagphys.absorption;em.ir.Kfloatnullablea_suExtinction in the SDSS u bandmagphys.absorption;em.opt.Ufloatnullablea_sgExtinction in the SDSS g bandmagphys.absorption;em.opt.Vfloatnullablea_srExtinction in the SDSS r bandmagphys.absorption;em.opt.Rfloatnullablea_siExtinction in the SDSS i bandmagphys.absorption;em.opt.Ifloatnullablea_szExtinction in the SDSS z bandmagphys.absorption;em.opt.Ifloatnullable
gdr3specGaia DR3 RP/BP (XP) Monte Carlo sampled spectra -This is a re-publication the Gaia DR3 RP/BP spectra in the IVOA Spectral -Data Model. It presents the continous spectra in sampled form, using a -Monte Carlo scheme to decorrelate errors, elaborated in this resource's -reference URL. The underlying tables are also available for querying -through TAP, which opens some powerful methods for mass-analysing the data.gdr3spec.spectraMonte Carlo sampled DR3 XP spectraThis table contains the sampled spectra, their errors (as the standard -deviation of the samples between the different realisations), and the -Gaia DR3 source_id. Join this table on source_id with gaia.dr3lite to -obtain information on the sources.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryfluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gdr3spec.ssametaSSA Metadata for the Monte Carlo-sampled Gaia DR3 XP spectra219196404phot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablesource_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablepreviewURL of a preview for the datasetmeta.ref.url;meta.previewcharnullableaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharnullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoublenullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperturedoublenullable
gdr3spec.withposMonte Carlo Sampled DR3 XP Spectra with Basic Object InformationThis table contains the data from gdr3spec.spectra plus position and -photometry from gaia.dr3lite. It is a view, and there is generally no -advantage to using it instead of manually performing the join.219196404source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoublenullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoublenullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatnullablefluxmean BP + RP combined spectrum fluxW.m**-2.nm**-1phot.flux;em.optfloatnullableflux_errormean BP + RP combined spectrum flux errorW.m**-2.nm**-1stat.error;phot.flux;em.optfloatnullable
gedr3autoGaia eDR3 Autocorrelation This is a table that simply gives, for each object in Gaia eDR3, the -identifier of its closest neighbour together with the distance of the -pair.gedr3auto.main This is a table that simply gives, for each object in Gaia eDR3, the -identifier of its closest neighbour together with the distance of the -pair.1900000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimarypartner_idIdentifier of the closest eDR3 objectmeta.id.assoclongindexeddistThe estimated distance between the two objects. No attempt is made to furnish this with an error estimate.degpos.angDistancedoubleindexednullable
gedr3distGeometric and photogeometric distances to 1.47 billion stars in Gaia -Early Data Release 3 (eDR3) -We estimate the distance from the Sun to sources in Gaia eDR3 that have -parallaxes. We provide two types of distance estimate, together with -their corresponding asymmetric uncertainties, using Bayesian posterior -density functions that we sample for each source. Our prior is based -on a detailed model of the 3D spatial, colour, and magnitude -distribution of stars in our Galaxy that includes a 3D map of -interstellar extinction. - -The first type of distance estimate is purely geometric, in that it only -makes use of the Gaia parallax and parallax uncertainty. This uses a -direction-dependent distance prior derived from our Galaxy model. The -second type of distance estimate is photogeometric: in addition to -parallax it also uses the source's G-band magnitude and BP-RP -colour. This type of estimate uses the geometric prior together with a -direction-dependent and colour-dependent prior on the absolute magnitude -of the star. - -Our distance estimate and uncertainties are quantiles, so are invariant -under logarithmic transformations. This means that our median estimate -of the distance can be used to give the median estimate of the distance -modulus, and likewise for the uncertainties. - -For applications that cannot be satisfied through TAP, you can download -a `full table dump`_. - -.. _full table dump: /gedr3dist/q/download/formgedr3dist.litewithdistGaia (e)DR3 lite distances subsetThis table joins the DR3 "lite" table -(consisting only of the columns necessary for the most basic -science) with the estimated geometric and photogeometric distances. -Note that this is an inner join, i.e., DR3 objects without -distance estimates will not show up here. - -Note: Due to current limitations of the postgres query planner, -this table cannot usefully be used in positional joins -("crossmatches"). See the `Tricking the query planner`_ example. - -.. _tricking the query planner: http://dc.g-vo.org/tap/examples#Trickingthequeryplanner1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongnullableraBarycentric Right Ascension in ICRS at epoch J2016.0degpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at epoch J2016.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at J2016.0. This is the tangent plane projection (i.e., multiplied by cos(δ)) of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatindexednullablepmdecProper motion in declination at J2016.0.mas/yrpos.pm;pos.eq.decfloatindexednullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch J2016.0. If looking for a distance, consider joining with gedr3dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_g_mean_flux_over_error.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_flux_over_errorIntegrated mean G flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_flux_over_errorIntegrated mean RP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_rp_mean_flux_over_error.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_flux_over_errorIntegrated mean BP flux divided by its error. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.stat.snr;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. To obtain error estimates, see phot_bp_mean_flux_over_error.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableastrometric_excess_noiseThis is the excess noise of the source, measuring the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). A value of 0 signifies a well-behaved source, a positive value signifies that the residuals are larger than expected.masstat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. For stars brighter than about 12 mag, this is the median of all single-epoch measurements. For fainter stars, RV estimation is from a co-added spectrum.km/sspect.dopplerVeloc.opt;em.opt.Ifloatnullableradial_velocity_errorError in radial_velocity; this is the error of the median for bright stars. For faint stars, it is derived from the cross-correlation function.km/sstat.error;spect.dopplerVelocfloatnullablepseudocolourEffective wavenumber of the source estimated in the final astrometric processing. The pseudocolour is the astrometrically estimated effective wavenumber of the photon flux distribution in the astrometric (G) band, estimated from the chromatic displacements of image centroids. The field is empty when chromaticity was instead taken into account using the photometrically determined ν_eff given in the field nu_eff_used_in_astrometry.um**-1em.wavenumber;phot.colorfloatnullablepseudocolour_errorStandard error of the pseudocolour.um**-1stat.error;em.wavenumber;phot.colorfloatnullablevisibility_periods_usedNumber of visibility periods (groups of observations at least 4 days apart) used in the astrometric solution. A small value (less than 10) indicates that the calculated parallax could be more vulnerable to error not reflected in the formal uncertainties.meta.number;obsshortastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedruweRenormalized Unit Weight Error; this is a revised measure for the overall consistency of the solution as defined by GAIA-C3-TN-LU-LL-124-01. A suggested cut on this is RUWE <1.40) See the note for details.stat.weightfloatnullabler_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3dist.main -We estimate the distance from the Sun to sources in Gaia eDR3 that have -parallaxes. We provide two types of distance estimate, together with -their corresponding asymmetric uncertainties, using Bayesian posterior -density functions that we sample for each source. Our prior is based -on a detailed model of the 3D spatial, colour, and magnitude -distribution of stars in our Galaxy that includes a 3D map of -interstellar extinction. - -The first type of distance estimate is purely geometric, in that it only -makes use of the Gaia parallax and parallax uncertainty. This uses a -direction-dependent distance prior derived from our Galaxy model. The -second type of distance estimate is photogeometric: in addition to -parallax it also uses the source's G-band magnitude and BP-RP -colour. This type of estimate uses the geometric prior together with a -direction-dependent and colour-dependent prior on the absolute magnitude -of the star. - -Our distance estimate and uncertainties are quantiles, so are invariant -under logarithmic transformations. This means that our median estimate -of the distance can be used to give the median estimate of the distance -modulus, and likewise for the uncertainties. - -For applications that cannot be satisfied through TAP, you can download -a `full table dump`_. - -.. _full table dump: /gedr3dist/q/download/form1470000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryr_med_geoThe median of the geometric distance posterior. The geometric distance estimate.pcpos.distancefloatindexednullabler_lo_geoThe 16th percentile of the geometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_geoThe 84th percentile of the geometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullabler_med_photogeoThe median of the photogeometric distance posterior. The photogeometric distance estimate.pcpos.distancefloatindexednullabler_lo_photogeoThe 16th percentile of the photogeometric distance posterior. The lower 1-sigma-like bound on the confidence interval.pcpos.distance;stat.minfloatnullabler_hi_photogeoThe 84th percentile of the photogeometric distance posterior. The upper 1-sigma-like bound on the confidence interval.pcpos.distance;stat.maxfloatnullableflagAdditional information on the solution. Do not use for filtering (see table note in the reference URL).meta.codecharnullable
gedr3mockGaia early DR3 Mock Catalogue (gedr3mock) This catalogue is a simulation of the Gaia EDR3 stellar content using -Galaxia (a tool to sample stars from a Besancon-like Milky Way model), -3d dust extinction maps and the latest PARSEC Isochrones. It is -mimicking the Gaia DR2 data model and an apparent magnitude limit of -G=20,7. Extinctions and photometry in different bands have also been -included in a supplementary table as well as uncertainty estimates -using scaled GDR2 errors. Additional magnitude limit per HEALpix maps -are provided, based on the mode in the magnitude distribution of Gaia -DR2 data.gedr3mock.generated_dataThis contains the data actually generated. Users probably want to use -the gdr2mock.main table that (fairly well) follows the Gaia DR2 data -model.1600000000teffeffective TemperatureKfloatfehlog of metallicity in solar units ('dex')floata0monochramatic Extinction at lambda=547.7nmmagfloatlumStellar luminositysolLumfloatlGalactic longitudedegdoublebGalactic latitudedegdoublesmassinitial mass in solar massessolMassfloatageAge of the starGyrfloatloggSurface gravity of starlog(cm/(s**2))floatphot_g_mean_magapparent G mag including extinctionmagfloatindexedphot_bp_mean_magapparent BP mag including extinctionmagfloatindexedphot_rp_mean_magapparent RP mag including extinctionmagfloatindexedphot_rvs_mean_magapparent RVS mag including extinctionmagfloatpopidPopulation ID according to the Besancon model. Including SMC/LMC = 10 and stellar clusters = 11shortmactactual (present) mass in solar massessolMassfloatphot_g_mean_mag_errorerror in Gmagfloata_gExtinction in Gmagfloata_bpExtinction in BPmagfloata_rpExtinction in RPmagfloata_rvsExtinction in RVSmagfloatparallaxparallax in masmasfloatindexedradial_velocityRadial velocity in km/skm/sfloatpm_raProper motion in projection of right ascensionmas/yrfloatpm_decProper motion in declinationmas/yrfloatparallax_errorparallax uncertainty in masmasfloatradial_velocity_errorRadial velocity uncertainty in km/skm/sfloatphot_g_n_obsNumber of photometric observations (trained from DR2 scaled to DR3 time)shortvisibility_periods_usedNumber of observations effectively used for the astrometric solutions (trained from DR2 scaled to DR3)shortsource_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table, .meta.id.crossintindexedrandom_indexRandom index that can be used to deterministically select subsetsintindexedd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshort
gedr3mock.maglim_5 -This table gives empirical magnitude limits for -G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels -of 5 (scale roughly ~2 degrees). For each band -we have 4 different variants: - -(1) no additional condition, -(2) parallax available, -(3) BP-RP available, -(4) parallax and BP-RP available. - -For BP mag limits we also require that BP is available. The magnitude -limits are approximated by the mode of the magnitude distribution in a -specific HEALpix. Since this mode estimator is prone to Poisson noise -in low density areas we report the magnitude limits in two flavours: - -(a) directly the mode estimator -(b) the same as the mode estimator, - -except that in healpixel with a stellar density below 1e5 sources per -square degree the limit is arbitrarily set to 20.7 mag. These magnitude -limits were created using the `gdr2_completeness package`_ and users -are encouraged to create custom-made magnitude limits with specific -conditions, e.g. RVS sample with good parallaxes. - -.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness12288hpxLevel 5 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3mock.maglim_6 -This table gives empirical magnitude limits for -G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels -of 6 (scale roughly ~1 degrees). For each band -we have 4 different variants: - -(1) no additional condition, -(2) parallax available, -(3) BP-RP available, -(4) parallax and BP-RP available. - -For BP mag limits we also require that BP is available. The magnitude -limits are approximated by the mode of the magnitude distribution in a -specific HEALpix. Since this mode estimator is prone to Poisson noise -in low density areas we report the magnitude limits in two flavours: - -(a) directly the mode estimator -(b) the same as the mode estimator, - -except that in healpixel with a stellar density below 1e5 sources per -square degree the limit is arbitrarily set to 20.7 mag. These magnitude -limits were created using the `gdr2_completeness package`_ and users -are encouraged to create custom-made magnitude limits with specific -conditions, e.g. RVS sample with good parallaxes. - -.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness49152hpxLevel 6 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3mock.maglim_7 -This table gives empirical magnitude limits for -G and BP bands derived from Gaia DR2 with G < 20.7 mag for HEALPixels -of 7 (scale roughly ~0.5 degrees). For each band -we have 4 different variants: - -(1) no additional condition, -(2) parallax available, -(3) BP-RP available, -(4) parallax and BP-RP available. - -For BP mag limits we also require that BP is available. The magnitude -limits are approximated by the mode of the magnitude distribution in a -specific HEALpix. Since this mode estimator is prone to Poisson noise -in low density areas we report the magnitude limits in two flavours: - -(a) directly the mode estimator -(b) the same as the mode estimator, - -except that in healpixel with a stellar density below 1e5 sources per -square degree the limit is arbitrarily set to 20.7 mag. These magnitude -limits were created using the `gdr2_completeness package`_ and users -are encouraged to create custom-made magnitude limits with specific -conditions, e.g. RVS sample with good parallaxes. - -.. _gdr2_completeness package: https://github.com/jan-rybizki/gdr2_completeness196608hpxLevel 7 HEALPix for which the magnitude limit applies.pos.healpixintindexedmaglim_gThe mode of the G magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_gThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_g_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallaxThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_g_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_g_parallax_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_g_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_g_parallax_colorThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_g_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_g_parallax_color_density_thresholdThe mode of the G magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bpThe mode of the BP magnitude distribution in the respective HEALPixmaginstr.sensitivityfloatnullablestarcount_bpThe number of stars in the respective HEALPix bin with G<20.7meta.numberintmaglim_bp_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallaxThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallaxThe number of stars in the respective HEALPix bin with G<20.7 and parallax measurementmeta.numberintmaglim_bp_parallax_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_colorThe number of stars in the respective HEALPix bin with G<20.7 and BP and RP measurementmeta.numberintmaglim_bp_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullablemaglim_bp_parallax_colorThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurementmaginstr.sensitivityfloatnullablestarcount_bp_parallax_colorThe number of stars in the respective HEALPix bin with G<20.7 and parallax and BP and RP measurementmeta.numberintmaglim_bp_parallax_color_density_thresholdThe mode of the BP magnitude distribution in the respective HEALPix when also requiring a parallax and BP and RP measurement. In HEALPixes with less than 1e5 stars per square degree the limit is set to 20.7 mag. This should reduce the noise of the mode estimator due to Poisson noise in low density areas.maginstr.sensitivityfloatnullable
gedr3mock.mainA synthetic Milky Way catalog mimicking Gaia EDR3 in stellar content -and data model.source_idHealpix number using Nside = 4096 with the nested scheme on equatorial coordinates times 2^35. The last digits of the source_id are reserved for a running number that serves as a unique identifier per HEALPix cell. This is formed in accordance with Gaia's source_id definition, but of course mock objects have no relation to any Gaia objects that may have an identical source_id.meta.id;meta.mainlongraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.rafloatnullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decfloatnullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epoch. If looking for a distance, consider joining with gdr2dist.main and using the distances from there.maspos.parallaxfloatindexednullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatindexednullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_rp_mean_fluxMean flux in the integrated RP band.s**-1phot.flux;em.opt.Rdoublenullablephot_rp_mean_flux_errorError in the mean flux in the integrated RP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Rfloatnullablephot_rp_mean_magMean magnitude in the integrated RP band. This is computed from the RP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Rfloatindexednullablephot_bp_mean_fluxMean flux in the integrated BP band.s**-1phot.flux;em.opt.Bdoublenullablephot_bp_mean_flux_errorError in the mean flux in the integrated BP band. Errors are computed from the dispersion about the weighted mean of the input calibrated photometry.s**-1stat.error;phot.flux;em.opt.Bfloatnullablephot_bp_mean_magMean magnitude in the integrated BP band. This is computed from the BP-band mean flux applying the magnitude zero-point in the Vega scale. No error is provided for this quantity as the error distribution is only symmetric in flux space. For errors small compared to the flux (less than 10%, say), the magnitude error is well approximated by 1.09*flux/flux_err.magphot.mag;em.opt.Bfloatindexednullablephot_bp_rp_excess_factorBP/RP excess factor estimated from the comparison of the sum of integrated BP and RP fluxes with respect to the flux in the G band. This measures the excess of flux in the BP and RP integrated photometry with respect to the G band. This excess is believed to be caused by background and contamination issues affecting the BP and RP data. Therefore a large value of this factor for a given source indicates systematic errors in the BP and RP photometry.stat.fit.goodnessfloatnullableradial_velocitySpectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. Warning: in the vicinity of bright stars, DR2 RVs can be grossly wrong. See arXiv:1901.10460 for details.km/sspect.dopplerVelocfloatnullableradial_velocity_errorThe radial velocity error is the error on the median to which a constant noise floor of 0.11 km/s has been added in quadrature to take into account the calibration contribution.km/sstat.error;spect.dopplerVelocfloatnullableastrometric_gof_alGoodness-of-fit statistic of the astrometric solution for the source in the along-scan direction (you probably want to use RUWE instead of this).stat.fit.goodnessfloatnullableastrometric_params_solvedThis is a binary code indicating which astrometric parameters were estimated for the source. A set bit means the parameter was estimated. The least-significant bit represents α, the next bits δ, parallax, PM(RA) and PM(De). For Gaia DR2 the only relevant values are 31 (all five parameters solved) and 3 (only positions).meta.codeshortnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelongindexedlGalactic longitude (converted from ra, dec)degpos.galactic.londoublenullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoublenullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullablephot_rp_n_obsNumber of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Rshortphot_bp_n_obsNumber of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.meta.number;obs;phot.mag;em.opt.Bshortbp_rpBP-RP colormagphot.color;em.opt.B;em.opt.Rfloatnullablebp_gBP-G colormagphot.color;em.opt.B;em.opt.Vfloatnullableg_rpG-RP colormagphot.color;em.opt.V;em.opt.Rfloatnullablephot_rvs_mean_mag[GeDR3mock only] apparent magnitude of the RVS band.magphot.color;em.opt.Ifloatnullablephot_g_mean_mag_error[GeDR3mock only] G mag error approximated by the symmetrised flux error.magphot.color;em.opt.Vfloatnullablephot_bp_mean_mag_error[GeDR3mock only] BP mag error (generated by scaling the G mag error with an empirical factor of 19.854 derived from GDR2).magphot.color;em.opt.Bfloatnullablephot_rp_mean_mag_error[GeDR3mock only] RP mag error (generated by scaling the G mag error with an empirical factor of 9.1205 derived from GDR2).magphot.color;em.opt.Rfloatnullablephot_rvs_mean_mag_error[GeDR3mock only] RVS mag error (generated by scaling the G mag error with with 30; this is essentially a wild guess which is probably too low if RVS magnitudes are provided at all).magphot.color;em.opt.Rfloatnullablerv_nb_transits[NULL] Number of transits (epochs) used to compute radial velocity.meta.number;obs;spect.dopplerVelocshortref_epoch[NULL] Reference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_q[NULL] Hipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noise[NULL] Excess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sig[NULL] Significance of excess noisestat.valuefloatnullableastrometric_n_obs_ac[NULL ]Total number of observations ACmeta.numbershortastrometric_n_obs_al[NULL] Total number of observations ALmeta.numbershortastrometric_n_bad_obs_ac[NULL] Number of bad observations ACmeta.numbershortastrometric_n_bad_obs_al[NULL] Number of bad observations ALmeta.numbershortastrometric_n_good_obs_ac[NULL] Number of good observations ACmeta.numbershortastrometric_n_good_obs_al[NULL] Number of good observations ALmeta.numbershortastrometric_chi2_al[NULL] Astrometric goodness-of-fit (χ²) in the AL direction; χ² values were computed for the ‘good’ AL observations of the source, without taking into account the astrometric excess noise (if any) of the source. They do, however, take into account the attitude excess noise (if any) of each observation.stat.fit.chi2floatnullableastrometric_primary_flag[NULL] Only primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortastrometric_pseudo_colour[NULL] Colour of the source assumed in the final astrometric processing, given as he effective wavenumber of the photon flux distribution in the astrometric (G) band. The value given in this field was astrometrically determined in a preliminary solution, using the chromatic displacement of image centroids calibrated by means of the effective wavenumbers (ν_eff) of primary sources calculated from BP and RP magnitudes. The field is empty when no such determination was possible, in which case a default value of 1.6 1/µm was assumed.um**-1floatnullablemean_varpi_factor_al[NULL] Mean parallax factor in the AL direction, computed from all the good observations of the source processed in the astrometry. The value given in this field is typically in the range [−0.23, +0.32] (1st and 99th percentiles). A value outside this range indicates a distribution of observations that is unfavourable for the determination of the parallax, and the calculated parallax could then be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties.stat.fit.paramfloatnullablevisibility_periods_usedNumber of visibility periods used in Astrometric solution. A visibility period is a group of observations separated from other groups by a gap of at least 4 days.meta.number;obsshortastrometric_sigma5d_max[NULL] The longest principal axis in the 5-dimensional error ellipsoid. This is useful for filtering out cases where one of the five parameters, or some linear combination of several parameters, is particularly ill-determined. It is measured in mas and computed as the square root of the largest singular value of the scaled 5 × 5 covariance matrix of the astrometric parameters.masstat.error;obs;stat.maxfloatnullablematched_observations[NULL] The number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_used[NULL] Type of prior used in in the astrometric solutionshortnullableastrometric_relegation_factor[NULL] Relegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_ac[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_al[NULL] Mean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_source[NULL] During data processing, this source happened to have been duplicated and one source only has been kept.shortd11y[GeDR3mock only] Probability that this source can be detected by Gaia, estimated according to interpolated Table 1 in 2019A&A...621A..86B, in percent (this is below 100 for fainter sources of close pairs).stat.likelihood;obsshortra_dec_corr[NULL] Correlation between right ascension and declinationstat.correlationfloatnullablera_pmra_corr[NULL] Correlation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corr[NULL] Correlation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corr[NULL] Correlation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corr[NULL] Correlation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corr[NULL] Correlation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corr[NULL] Correlation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corr[NULL] Correlation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corr[NULL] Correlation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corr[NULL] Correlation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3[NULL] Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4[NULL] Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4[NULL] Degree of concentration of scan directions across the sourcefloatnullablepriam_flags[NULL] Flags describing the status of the astrophysical parameters Teff, A G and E[BP-RP] (i.e., those determined by Apsis-Priam). See the release documentation.meta.codelongnullableflame_flags[NULL] Flags describing the status of the astrophysical parameters radius and luminosity (i.e., those determined by Apsis-FLAME). See the release documentation.meta.codelongnullableteff_valEffective temperature of the starKphys.temperaturefloatnullableteff_percentile_lower[Null] Lower uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 16th percentile of its PDF.Kphys.temperature;stat.minfloatnullableteff_percentile_upper[Null] Upper uncertainty bound of the effective temperature estimate from Apsis-Priam. This is the 84th percentile of its PDF.Kphys.temperature;stat.maxfloatnullablea_g_valLine-of-sight extinction in the G band, A_Gmagphys.absorptionfloatnullablea_g_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_g_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the G-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_bp_valEstimate of the line-of-sight extinction in the BP-band from Apsis-Priammagphys.absorptionfloatnullablea_bp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_bp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the BP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rp_valEstimate of the line-of-sight extinction in the RP-band from Apsis-Priammagphys.absorptionfloatnullablea_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RP-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablea_rvs_valEstimate of the line-of-sight extinction in the RVS-band from Apsis-Priammagphys.absorptionfloatnullablea_rvs_percentile_lower[Null] Lower uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablea_rvs_percentile_upper[Null] Upper uncertainty bound of the line-of-sight extinction in the RVS-band estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullablee_bp_min_rp_valLine-of-sight reddening E(BP-RP)magphys.absorptionfloatnullablee_bp_min_rp_percentile_lower[Null] Lower uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 16th percentile of its PDF.magphys.absorption;stat.minfloatnullablee_bp_min_rp_percentile_upper[Null] Upper uncertainty bound of the line-of-sight reddening E(BP-RP) estimate from Apsis-Priam. This is the 84th percentile of its PDF.magphys.absorption;stat.maxfloatnullableradius_valStellar radius in solar radiisolRadphys.size.radiusfloatnullableradius_percentile_lower[Null] Lower uncertainty bound of the radius estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solRadphys.size.radius;stat.minfloatnullableradius_percentile_upper[Null] Upper uncertainty bound of the radius estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solRadphys.size.radius;stat.maxfloatnullablelum_valStellar luminosity in solar luminosities.solLumphys.luminosityfloatnullablelum_percentile_lower[Null] Lower uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 16th percentile of its PDF.solLumphys.luminosity;stat.minfloatnullablelum_percentile_upper[Null] Upper uncertainty bound of the luminosity estimate from Apsis-FLAME. This is the 84th percentile of its PDF.solLumphys.luminosity;stat.maxfloatnullablefeh[GeDR3mock only] Fe/H as log10 of solar ratio ('dex')phys.abund.Fefloatnullablea0[GeDR3mock only] Monochromatic extinction at lambda = 547.7nmmagphys.absorptionfloatnullableinitial_mass[GeDR3mock only] Initial mass of the starsolMassphys.massfloatnullablecurrent_mass[GeDR3mock only] Current mass of the starsolMassphys.massfloatnullableage[GeDR3mock only] Age of the starGyrtime.agefloatnullablelogg[GeDR3mock only] Logarithm of surface gravity.log(cm/(s**2))phys.gravityfloatnullablepopid[GeDR3mock only] Population ID according to the Besancon model. 10=SMC/LMC, 11=stellar clusterssrc.classshortpm_total[GeDR3mock only] Total proper motion of the star, i.e., sqrt(pmra^2+pmdec^2).mas/yrpos.pmfloatnullableindex_parsec[GeDR3mock only] Foreign key into the photometry/extinction table.meta.id.crossintindexedgedr3mock.parsec_propsindex_parsecindex_parsec
gedr3mock.parsec_propsParsec-based photometry and extinction for GeDR3 Mock This table is intended to augment the Gaia photometry of GeDR3 Mock -stars with other bands and extinctions (Sloan, Johnson and 2MASS). The -grid was generated by binning all isochrones in logg, teff, and feh -and taking the median values of all isochrone models that fall within -one bin. We also report the median values of some astrophysical -parameters so that one can check how far the actual star abundances -deviate from the bin's median. For the extinction we report the -extinction for the specific isochrone bin in a specific photometric -band for 6 different values of monochromatic extinction, A_0, i.e. -1,2,3,5,10,20 mag. - -Sometimes stars in GeDR3 Mock depart from the isochrone grid, because, -e.g., the feh value is outside of the grid or values have been -interpolated by Galaxia in the catalog generation from the Parsec -isochrones. Then the index_parsec is assigned to the nearest neighbour -in log_lum and log_teff.243238index_parsecThe primary key of the photometry table, useful for joining with index_parsec in gedr3mock.main. This has the format LLLTTTFFF indexing bins in log_lum, log_teff, feh in the parsec isochrones. To find the actual bin centers, see the log_lum, log_teff, and meh_ini columns.meta.refintindexedmeh_iniLog of initial model metalicity at the center of this bin.phys.abund.zfloatnullablelog_ageMedian log of model star age at the parsec bin.log(yr)time.agefloatnullablem_iniMedian of the initial (zero age) mass of all model stars in the parsec bin.solMassphys.massfloatnullablem_actMedian of the current (at log_age) mass of all model star in the parsec bin.solMassphys.massfloatnullablelog_lumMedian Log of luminosity of all model stars in the parsec bin.log(solLum)phys.luminosityfloatnullablelog_teffMedian Log of the effective temperature of all model stars in the parsec bin.log(K)phys.temperature.effectivefloatnullablelog_gravMedian Log of the surface gravity of all model stars in the parsec bin.log(m/s**2)phys.gravityfloatnullablegaia_gMedian absolute magnitude in the Gaia G band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablegaia_bpbrMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_bpftMedian absolute magnitude in the Gaia BP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullablegaia_rpMedian absolute magnitude in the Gaia RP band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablegaia_rvsMedian absolute magnitude in the Gaia RVS band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_uMedian absolute magnitude in the Johnson U band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullableubv_bMedian absolute magnitude in the Johnson B band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Bfloatnullableubv_vMedian absolute magnitude in the Johnson V band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullableubv_rMedian absolute magnitude in the Johnson R band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullableubv_iMedian absolute magnitude in the Johnson I band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullableubv_jMedian absolute magnitude in the Johnson J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullableubv_hMedian absolute magnitude in the Johnson H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullableubv_kMedian absolute magnitude in the Johnson K band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullableubv_lMedian absolute magnitude in the Johnson L band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.3-4umfloatnullableubv_mMedian absolute magnitude in the Johnson M band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.4-8umfloatnullablesloan_uMedian absolute magnitude in the SDSS u band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ufloatnullablesloan_gMedian absolute magnitude in the SDSS g band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Vfloatnullablesloan_rMedian absolute magnitude in the SDSS r band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Rfloatnullablesloan_iMedian absolute magnitude in the SDSS i band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullablesloan_zMedian absolute magnitude in the SDSS z band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.opt.Ifloatnullabletmass_jMedian absolute magnitude in the 2MASS J band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Jfloatnullabletmass_hMedian absolute magnitude in the 2MASS H band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Hfloatnullabletmass_ksMedian absolute magnitude in the 2MASS K' band (note that no extinction is applied) in the respective isochrone bin.magphot.mag;em.ir.Kfloatnullablea0_1_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_1_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_1_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_1_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_1_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_1_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_1_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_1_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_1_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_1_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 1 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_2_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_2_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_2_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_2_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_2_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_2_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_2_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_2_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_2_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_2_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 2 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_3_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_3_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_3_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_3_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_3_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_3_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_3_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_3_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_3_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_3_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 3 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_5_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_5_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_5_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_5_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_5_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_5_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_5_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_5_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_5_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_5_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 5 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_10_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_10_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_10_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_10_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_10_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_10_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_10_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_10_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_10_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_10_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 10 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullablea0_20_gaia_gMedian extinction in the Gaia G band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_gaia_bpbrMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_bpftMedian extinction in the Gaia BP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_gaia_rpMedian extinction in the Gaia RP band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_gaia_rvsMedian extinction in the Gaia RVS band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_uMedian extinction in the SDSS u band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_sloan_gMedian extinction in the SDSS g band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_sloan_rMedian extinction in the SDSS r band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_sloan_iMedian extinction in the SDSS i band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_sloan_zMedian extinction in the SDSS z band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_tmass_jMedian extinction in the 2MASS J band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Jfloatnullablea0_20_tmass_hMedian extinction in the 2MASS H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_tmass_ksMedian extinction in the 2MASS Ks band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_uMedian extinction in the Johnson U band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ufloatnullablea0_20_ubv_bMedian extinction in the Johnson B band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Bfloatnullablea0_20_ubv_vMedian extinction in the Johnson V band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Vfloatnullablea0_20_ubv_rMedian extinction in the Johnson R band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Rfloatnullablea0_20_ubv_iMedian extinction in the Johnson I band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.opt.Ifloatnullablea0_20_ubv_jMedian extinction in the Johnson L band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.3-4umfloatnullablea0_20_ubv_hMedian extinction in the Johnson H band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Hfloatnullablea0_20_ubv_kMedian extinction in the Johnson K band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.Kfloatnullablea0_20_ubv_mMedian extinction in the Johnson M band for monochromatic extinction (A_0) of 20 mag for the respective isochrone binmagphys.absorption;em.ir.4-8umfloatnullable
gedr3spurA classifier for spurious astrometric solutions in Gaia EDR3 This table contains estimates of the "fidelity" of Gaia eDR3 -astrometric solutions, a measure of the likelihood the eDR3 solution -is physical rather than spurious obtained using a neural network -trained on a small, hand-selected sample.gedr3spur.main This table contains estimates of the "fidelity" of Gaia eDR3 -astrometric solutions, a measure of the likelihood the eDR3 solution -is physical rather than spurious obtained using a neural network -trained on a small, hand-selected sample.1500000000source_idGaia DR3 unique source identifier. Note that this *cannot* be matched against the DR1 or DR2 source_ids.meta.id;meta.mainlongindexedprimaryfidelity_v2A probability that eDR3 has a good astrometric solution for this source, with values between 0 (meaning likely spurious solution) and 1 (meaning likely good solution). This is the published probability estimate.stat.fitfloatindexednullabletheta_arcsec_worst_sourceDistance to the eDR3 source within 30 arcsec of the object for which ΔG-θ is maximal. See norm_dg for details.arcsecpos.angDistancefloatnullablenorm_dgThis is a heuristic measure for contamination by bright stars in the neighbourhood. It is computed as ΔG-θ, where θ is the distance to another Gaia eDR3 object in arcsec (reported in theta_arcsec_worst_source), and ΔG is the magnitude difference in mag. This column gives the maximum of the values for all eDR3 sources within 30 arcsecs of the object.instr.backgroundfloatnullabledist_nearest_neighbor_at_least_m2_brighterDistance to the nearest neighbour in gaia_source at least 2 m fainter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_0_brighterDistance to the nearest neighbour in gaia_source at least as bright as this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_2_brighterDistance to the nearest neighbour in gaia_source at least 2 m brighter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_4_brighterDistance to the nearest neighbour in gaia_source at least 4 m brighter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_6_brighterDistance to the nearest neighbour in gaia_source at least 6 m brighter than this source.arcsecpos.angDistancefloatnullabledist_nearest_neighbor_at_least_10_brighterDistance to the nearest neighbour in gaia_source at least 10 m brighter than this source.arcsecpos.angDistancefloatnullablefidelity_v1A probablity that eDR3 has a good astrometric solution for this source, with values between 0 (meaning likely spurious solution) and 1 (meaning likely good solution). This comes from a first version of the estimator that was reviewed based on an astro-ph paper.stat.fitfloatnullable
glotsGloTS, the Global TAP Schema -The global TAP schema collects information on -tables and columns from known TAP servers. This facilitates locating -queriable data by physics (via UCD) or keywords (via description). - -Note that this shouldn't really be necessary as all information -present here should be exposed through Registry records. However, -in reality data providers currently are much more liable to give -column metadata in their tap_schema than in their Registry records. -Hence, for the time being, we maintain this service by harvesting -tap_schemas about monthly.glots.columnsA table of columns within the tables listed in glots.tables.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columncharindexednullableunitUnit in VO standard formatcharnullableucdUCD of column (some services still have 1.0 UCDs).charindexednullableutypeUtype of columncharnullabledatatypeADQL datatypecharnullable"size"Length of variable length datatypesintnullableprincipalIs column principal?charnullableindexedIs there an index on this column?intnullablestdIs this a standard column?charnullableglots.tablesivoidivoidtable_nametable_name
glots.servicesA table of TAP services harvested from the registry (and some -spoon-fed).ivoidIVOA identifier of providing servicecharindexedprimaryaccessurlBase URL of TAP endpointcharnullablenextharvestNext scheduled harvest of datacharnullableharvestintervalApproximate interval of harvestdintnullablelastsuccessLast successful harvest of this servicecharnullable
glots.tablesA table of tables accesible through the TAP services known to -glots.services.ivoidIVOA identifier of providing servicecharindexedprimarytable_nameFully qualified table namecharindexedprimarytable_descBrief description of the tableunicodeCharindexednullableutypeutype if the table corresponds to a data modelcharnullableglots.servicesivoidivoid
gps1The Gaia-PS1-SDSS (GPS1) Proper Motion Catalog -This catalog combines Gaia DR1, Pan-STARRS 1, SDSS and 2MASS astrometry -to compute proper motions for 350 million sources across three-fourths of -the sky down to a magnitude of mr≈20. Positions of galaxies from Pan-STARRS 1 -are used to build a reference frame for PS1, SDSS, and 2MASS data. -Gaia DR1 is adapted to that reference frame by exploiting that locally, -proper motions are linear. - -GPS1 has a characteristic systematic error of less than 0.3 mas/yr, and -a typical precision of 1.5−2.0 mas/yr. The proper motions have been -validated using galaxies, open clusters, distant giant stars and QSOs. In -comparison with other published faint proper motion catalogs, GPS1's -systematic error (<0.3 mas/yr) is about 10 times better than that of PPMXL -and UCAC4 (>2.0 mas/yr). Similarly, its precision (~1.5 mas/yr) is -an improvement by ∼ 4 times relative to PPMXL and UCAC4 (∼6.0 mas/yr). -For QSOs, the precision of GPS1 is found to be worse (∼2.0−3.0 mas/yr), -possibly due to their particular differential chromatic refraction (DCR).gps1.mainGPS1 main table with some deviations from the published paper. In -particular note that Gaia and Pan-STARRS1 photometry results from -blind crossmatching; see d_g and d_ps1 fields for the offsets in the -respective crossmatches.350000000obj_idUnique object identifier (this is not the Pan-STARRS1 identifier).meta.id;meta.mainlongindexedraRight Ascension from fit (ICRS, Epoch J2010).degpos.eq.ra;meta.maindoubleindexednullabledecDeclination from fit (ICRS, Epoch J2010).degpos.eq.dec;meta.maindoubleindexednullablee_raError in Right Ascension from Gaia DR1.degstat.error;pos.eq.ra;meta.mainfloatnullablee_decError in Declination from Gaia DR1.degstat.error;pos.eq.dec;meta.mainfloatnullablera_ps1Right Ascension from Pan-STARRS1degpos.eq.radoublenullabledec_ps1Declination from Pan-STARRS1degpos.eq.decdoublenullablepmraProper motion in RA with cos(δ) applied; robust fit.deg/yrpos.pm;pos.eq.rafloatnullablee_pmraError of proper motion in RA, cos(δ) applied; robust fit.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declination; robust fit.deg/yrpos.pm;pos.eq.decfloatnullablee_pmdeError of proper motion in Declination; robust fit.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmra_xProper motion in RA with cos(δ) applied; x-validation fit.deg/yrpos.pm;pos.eq.rafloatnullablee_pmra_xError of proper motion in RA, cos(δ) applied; x-validation fit.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmde_xProper motion in Declination; x-validation fit.deg/yrpos.pm;pos.eq.decfloatnullablee_pmde_xError of proper motion in Declination; x-validation fit.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmra_ngProper motion in RA with cos(δ) applied; fit without Gaia.deg/yrpos.pm;pos.eq.rafloatnullablee_pmra_ngError of proper motion in RA, cos(δ) applied; fit without Gaia.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmde_ngProper motion in Declination; fit without Gaia.deg/yrpos.pm;pos.eq.decfloatnullablee_pmde_ngError of proper motion in Declination; fit without Gaia.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmra_psProper motion in RA with cos(δ) applied; fit with only Pan-STARRS.deg/yrpos.pm;pos.eq.rafloatnullablee_pmra_psError of proper motion in RA, cos(δ) applied; fit with only Pan-STARRS.deg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmde_psProper motion in Declination; fit with only Pan-STARRS.deg/yrpos.pm;pos.eq.decfloatnullablee_pmde_psError of proper motion in Declination; fit with only Pan-STARRS.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablechi2pmraReduced χ² for the robust fit of proper motion in RAstat.fit.chi2;pos.pm;pos.eq.rafloatnullablechi2pmdeReduced χ² for the robust fit of proper motion in Declinationstat.fit.chi2;pos.pm;pos.eq.decfloatnullablechi2pmra_psReduced χ² for the Pan-STARRS 1-only fit of proper motion in RAstat.fit.chi2;pos.pm;pos.eq.rafloatnullablechi2pmde_psReduced χ² for the Pan-STARRS 1-only fit of proper motion in Declinationstat.fit.chi2;pos.pm;pos.eq.decfloatnullablemaggg-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Vfloatnullablee_maggError in g-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Vfloatnullablemagrr-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Rfloatnullablee_magrError in r-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Rfloatnullablemagii-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Ifloatnullablee_magiError in i-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Ifloatnullablemagzz-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Ifloatnullablee_magzError in z-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.Ifloatnullablemagyy-band PSF magnitude from Pan-STARRS1 DR1magphot.mag;em.opt.Ifloatnullablee_magyError in y-band PSF magnitude from Pan-STARRS1 DR1magstat.error;phot.mag;em.opt.IfloatnullablemagjJ-band magnitude from 2MASSmagphot.mag;em.ir.Jfloatnullablee_magjError in J-band magnitude from 2MASSmagstat.error;phot.mag;em.ir.JfloatnullablemaghH-band magnitude from 2MASSmagphot.mag;em.ir.Hfloatnullablee_maghError in H-band magnitude from 2MASSmagstat.error;phot.mag;em.ir.HfloatnullablemagkK_s-band magnitude from 2MASSmagphot.mag;em.ir.Kfloatnullablee_magkError in K_s-band magnitude from 2MASSmagstat.error;phot.mag;em.ir.KfloatnullablemaggaiaG-band magnitude from Gaiamagphot.mag;em.opt.Vfloatnullablee_maggaiaError in G-band magnitude from Gaiamagstat.error;phot.mag;em.opt.Vfloatnullablen_obsps1Number of PS1 SeasonAVG detections.meta.number;obsshortn_obsnumber of all the detections.meta.number;obsshortsurveysSum of source codes for the source catalogues that went into this row. Pan-STARRS is always present. Source codes: 5 -- 2MASS; 10 -- SDSS, 20 -- Gaia.meta.codeshortd_ps1Distance between position in GPS1 and the associated (closest) position in Pan-STARRS1 used for (not accounting for the epoch difference).arcsecpos.eq;arith.difffloatnullabled_gDistance between position in GPS1 and the associated (closest) position in Gaia DR1 (not accounting for the epoch difference).arcsecpos.eq;arith.difffloatnullable
hdgaiaThe Henry Draper Catalog with Gaia IDs This is the Henry Draper catalog (HD, Cannon & Pickering 1918-1924) -as distributed by the Astronomical Data Center in 1989 (Vizier -III/135A), with Gaia DR2 source_ids and positions added. The link to -modern Gaia DR2 was done through Fabricius et al's match between HD -and Tycho 2 (Vizier IV/25), TGAS to match Tycho 2 and Gaia DR1, and -Gaia DR2 to match against Gaia DR1.hdgaia.main This is the Henry Draper catalog (HD, Cannon & Pickering 1918-1924) -as distributed by the Astronomical Data Center in 1989 (Vizier -III/135A), with Gaia DR2 source_ids and positions added. The link to -modern Gaia DR2 was done through Fabricius et al's match between HD -and Tycho 2 (Vizier IV/25), TGAS to match Tycho 2 and Gaia DR1, and -Gaia DR2 to match against Gaia DR1.272150hdHD number for this objectmeta.id;meta.mainintindexedprimarydmDurchmusterung identifier, taken either from the Bonner Durchmusterung (BD), Cordoba Durchmusterung (CD), or Cape Photographic Durchmusterung (CPD); stars not given in any of them are referenced by their AGK number.meta.id.crosscharnullablera_origOriginal right ascension for equinox J1900.0. Note that this position is only good to about an arcminute.pos.eq.racharnullabledec_origOriginal declination for equinox J1900.0. Note that this position is only good to about an arcminute.pos.eq.deccharnullablera_orig_2000Original right ascension for equinox J2000.0 (precession done by DC staff). Note that this position is only good to about an arcminute.pos.eq.rafloatnullabledec_orig_2000Original declination for equinox J2000.0 (precession done by DC staff). Note that this position is only good to about an arcminute.pos.eq.decfloatnullablemv_meas'0' if the m_v is a measured value, '1' if it's a value inferred from m_pg and the spectral type.meta.codecharm_vPhotovisual magnitude or the star, except for magnitudes >= 20, which are object type flags (see note).magphot.mag;em.opt.Vfloatindexednullablemv_combC if m_v is a combined magnitude (with a neighbouring star given in this catalogue), NULL otherwise.meta.codecharnullablempg_meas'0' if the m_pg is a measured value, '1' if it's a value inferred from m_v and the spectral type.meta.codecharm_pgPhotographic magnitude or the star, except for magnitudes >= 20, which are object type flags (see note).magphot.mag;em.opt.Bfloatnullablempg_combC if m_pg is a combined magnitude (with a neighbouring star given in this catalogue), NULL otherwise.meta.codecharnullablespectralSpectral type, given in upper and lower case as in the published catalog.src.sptypecharindexednullablepg_intensityPhotographic intensity of the spectrum estimated by Annie Cannon. The faintest spectra which could be classified with certainty were assigned a value of 1, while the densest are given as 10. For stars having two intensities in the published catalog, only the first is given here.meta.code.qualshortnullableremarksRemarks. See note for what the letters mean.meta.codecharnullablen_hdNumber of HD stars matched to a Tycho 2 source by Fabricius et al, 2002A&A...386..709F.meta.numbershortnullablen_tycNumber of Tycho 2 stars matched to a HD source by Fabricius et al, 2002A&A...386..709F.meta.numbershortnullablesource_idGaia DR2 source_id matching the HD object through Fabricius' Tycho 2 match and Gaia DR2's tycho2_best_neighbour. For four ambiguous matches, a unique match was randomly chosen (see reference URL).meta.id.crosslongnullablesource_id3Gaia eDR3 source_id matching the HD object through Fabricius' Tycho 2 match and Gaia DR2's tycho2_best_neighbour, and then Gaia eDR3's dr2_best_neighbour.meta.id.crosslongnullablegaia_raICRS Right Ascension from Gaia eDR3 (i.e., Epoch J2016)degpos.eq.ra;meta.maindoubleindexednullablegaia_decICRS Declination from Gaia eDR3 (i.e., Epoch J2016)degpos.eq.dec;meta.maindoubleindexednullable
hiicounterReference HII Regions for Abundance Determination A table containing reference data for HII regions. We also give a -source code to compute abundances and electron temperatures in HII -regions from strong emission lines.hiicounter.data A table containing reference data for HII regions. We also give a -source code to compute abundances and electron temperatures in HII -regions from strong emission lines.414identIdentifier of the HII region in this catalogmeta.id;meta.mainintlogr3Log of [OIII] R_3 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullablelogr2Log of [OII] R_2 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullablelogn2Log of [NII] N_2 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullablelogs2Log of [SII] S_2 line intensity relative to Hβspect.line.intensity;arith.ratiofloatnullableo_hT_e-based oxygen abundance given as 12+log(O/H)phys.abund;arith.ratiofloatnullablen_hT_e-based nitrogen abundance given as 12+log(N/H)phys.abund;arith.ratiofloatnullablet3Electron temperature derived as given in t3src, reduced to t_3([O III])Kphys.temperature.electronfloatnullablet3srcLines used for determination of t_3meta.code;phys.temperature.electroncharnullableregion_nameName of the HII region.meta.id;srccharnullablesrcReference to the source of the data quoted.meta.bib.bibcodecharnullablehostalphaICRS RA of host object (from Simbad)pos.eq.ra;meta.mainfloatindexednullablehostdeltaICRS Dec of host object (from Simbad)pos.eq.dec;meta.mainfloatindexednullable
hipparcosHipparcos CatalogueThe main result catalog from the ESA Hipparcos satellite, obtained -November 1989 through March 1993. In the GAVO DC, several columns were -left out and all angles are given in degrees.hipparcos.mainThe main result catalog from the ESA Hipparcos satellite, obtained -November 1989 through March 1993. In the GAVO DC, several columns were -left out and all angles are given in degrees.117955hipnoIdentifier (HIP number)meta.id;meta.mainintindexedprimaryraRight ascension ICRS (Epoch J1991.25)degpos.eq.ra;meta.maindoubleindexeddecDeclination ICRS (Epoch J1991.25)degpos.eq.dec;meta.maindoubleindexedvmagMagnitude in Johnson Vmagphot.mag;em.opt.VfloatnullablevarflagCoarse variability flagmeta.code;src.varbooleanwhatposPosition is for -- A-Z: multiple component, *: Photocenter, +: Center of massmeta.notecharnullableparallaxTrigonometric parallaxdegpos.parallax.trigfloatnullablepmraProper motion in RA, cos(delta) applieddeg/yrpos.pm;pos.eq.radoublenullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decdoublenullablee_radegStandard error in RA*cos(delta)degstat.errorfloatnullablee_dedegStandard error in DEdegstat.errorfloatnullablee_parallaxStandard error of parallaxdegstat.errorfloatnullablee_pmraStandard error in PM in RAdeg/yrstat.errorfloatnullablee_pmdeStandard error in PM in Decdeg/yrstat.errorfloatnullablef2Goodness-of-fit parameter, >3 means bad datastat.fit.goodnessfloatnullablehpmagMedian magnitude in Hipparcos systemmagphot.mag;em.opt.Vfloatnullablee_hpmagStandard error on median magnitudemagstat.errorfloatnullablehpscatScatter on median magnitudemagphot.mag;em.opt.Vfloatnullableo_hpmagNumber of observations in median magnitudemeta.numbershortnullablewhatmagMag is for -- A-Z: multiple component, *: combined and corrected for attenuation, +: combined and not corrected for attenuationmeta.code.multipcharnullablehpmaxHpmag at maximum (5th percentile)magphot.mag;em.opt.VfloatnullablehpminHpmag at minimum (95th percentile)magphot.mag;em.opt.VfloatnullableperiodVariability periodstime.periodfloatnullablesptypeSpectral type from various sourcessrc.spTypecharnullablemultflagMultiplicity flag, see note.meta.code.multipcharnullablebinpaPosition angle between componentsdegpos.posAng;src.orbitalfloatnullablebinsepAngular separation between componentsarcsecpos.angDistance;src.orbitalfloatnullablebinseperrStandard error on ang. separationarcsecstat.error;pos.angDistance;src.orbitalfloatnullablemagdiffMagnitude difference of componentsmagphot.mag;arith.difffloatnullable
hppunionGAVO Historical Photographic Plate Archive GHPPA -GAVO's historical photographic plate archive (GHHPA) is a -collection of various digitized historical photographic -plates. It currently exposes: - -* the scans of plates of selected Kapteyn special fields obtained - at Potsdam -* the Palomar-Leiden Trojan surveys, 1960-1977, -* a collection of plates obtained at Boyden Station, South Africa, - kept at various German observatories. - -Other plate collections kept by GAVO include the Heidelberg -Digitized Astronomical Plates HDAP, -ivo://org.gavo.dc/lswscans/res/positions/siap, and the APPLAUSE -database from Potsdam.hppunion.main -GAVO's historical photographic plate archive (GHHPA) is a -collection of various digitized historical photographic -plates. It currently exposes: - -* the scans of plates of selected Kapteyn special fields obtained - at Potsdam -* the Palomar-Leiden Trojan surveys, 1960-1977, -* a collection of plates obtained at Boyden Station, South Africa, - kept at various German observatories. - -Other plate collections kept by GAVO include the Heidelberg -Digitized Astronomical Plates HDAP, -ivo://org.gavo.dc/lswscans/res/positions/siap, and the APPLAUSE -database from Potsdam.1897accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableobjectObject being observed, Simbad-resolvable formmeta.idcharnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharnullabledatalink_urlURL of a datalink document (cutout service, ancillary data) for this dataset.charnullable
hsoyThe HSOY Catalog -HSOY is a catalog of 583'001'653 objects with precise astrometry based on -PPMXL and Gaia DR1. Typical formal errors at mean epoch in proper motion are -below 1 mas/yr for objects brighter than 10 mag, and about 5 mas/yr at the -faint end (about 20 mag). South of -30 degrees, astrometry is significantly -worse. HSOY also contains, where available, USNO-B, Gaia, and 2MASS -photometry. HSOY's positions and proper motions are given for epoch J2000. -The catalog becomes severely incomplete faintwards of 16 mag in the G-band. -The mean epochs are typically very close to Gaia's J2015. - -HSOY still contains about 0.7% spurious close -"binaries" (non-matched stars) from the original USNO-B (marked with non-NULL -clone). Also, failed matches within Gaia DR1 contribute another 1.5% spurious -pairs (marked with non-NULL comp). In both cases, astrometry presumably is -sub-standard. - -More information is available at http://dc.g-vo.org/hsoy.hsoy.mainHsoy Object Catalog -HSOY is a catalog of 583'001'653 objects with precise astrometry based on -PPMXL and Gaia DR1. Typical formal errors at mean epoch in proper motion are -below 1 mas/yr for objects brighter than 10 mag, and about 5 mas/yr at the -faint end (about 20 mag). South of -30 degrees, astrometry is significantly -worse. HSOY also contains, where available, USNO-B, Gaia, and 2MASS -photometry. HSOY's positions and proper motions are given for epoch J2000. -The catalog becomes severely incomplete faintwards of 16 mag in the G-band. -The mean epochs are typically very close to Gaia's J2015. - -HSOY still contains about 0.7% spurious close -"binaries" (non-matched stars) from the original USNO-B (marked with non-NULL -clone). Also, failed matches within Gaia DR1 contribute another 1.5% spurious -pairs (marked with non-NULL comp). In both cases, astrometry presumably is -sub-standard. - -More information is available at http://dc.g-vo.org/hsoy.590000000ipixThe PPMXL object identifier, which in turn is the q3c ipix of the original USNO-B object; for HSOY, only (ipix, comp) is a unique identifier (primary key). The recommended identifier form is 'HSOY ipix.comp', where comp=0 for NULL comps. This is what the SCS generates.meta.id.crosslongindexedcompIf non-null this indicates that multiple Gaia objects matched the PPMXL object; this may indicate bona fide multiple stars, but more likely is due to failed matching of Gaia observations at different epochs. In both cases, proper motions must be used with care. The index is artificial, i.e., no primary, secondary, etc, is implied. ipix+comp together are a primary key to hsoy.main.meta.code.multipshortnullableraj2000Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablee_raepraMean error in RA*cos(delta) at mean epochdegstat.error;pos.eq.ra;meta.mainfloatnullablee_deepdeMean error in Dec at mean epochdegstat.error;pos.eq.dec;meta.mainfloatnullablepmraProper Motion in RA*cos(delta)deg/yrpos.pm;pos.eq.rafloatnullablepmdeProper Motion in Decdeg/yrpos.pm;pos.eq.decfloatnullablee_pmraMean error in pmRA*cos(delta)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error in pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullableepraMean Epoch (RA)yrtime.epoch;pos.eq.rafloatnullableepdeMean Epoch (Dec)yrtime.epoch;pos.eq.decfloatnullablejmagJ selected default magnitude from 2MASSmagphot.mag;em.IR.Jfloatindexednullablee_jmagJ total magnitude uncertaintymagstat.error;phot.mag;em.IR.JfloatnullablehmagH selected default magnitude from 2MASSmagphot.mag;em.IR.Hfloatnullablee_hmagH total magnitude uncertaintymagstat.error;phot.mag;em.IR.HfloatnullablekmagK_s selected default magnitude from 2MASSmagphot.mag;em.IR.Kfloatindexednullablee_kmagK_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullableb1magB mag from USNO-B, first epochmagphot.mag;em.opt.Bfloatnullableb2magB mag from USNO-B, second epochmagphot.mag;em.opt.Bfloatnullabler1magR mag from USNO-B, first epochmagphot.mag;em.opt.Rfloatnullabler2magR mag from USNO-B, second epochmagphot.mag;em.opt.RfloatnullableimagI mag from USNO-Bmagphot.mag;em.opt.IfloatnullablemagsurveysSurveys the USNO-B magnitudes are taken frommeta.codecharnullablenobsNumber of observations contributing to this column (always nobs(ppmxl)+1)meta.number;obsshortnullablegaia_idUnique source identifiermeta.idlongindexednullablephot_g_mean_magMean magnitude in the G band from Gaia DR1. Magnitudes for which err_flux/flux>0.1 have been dropped.magphot.mag;em.opt;stat.meanfloatindexednullablee_phot_g_mean_magEstimated error in Gaia G-band magnitude. This is estimated as 1.09*err_flux/flux which is good as a symmetric 1 σ-error of the magnitude to at least within a few percent when err_flux/flux is smaller than 0.1, as it is for the HSOY objects.s**-1stat.error;phot.mag;em.opt.VfloatnullablecloneIf 1, more than one PPMXL object matched to this Gaia object (i.e.: proper motion is probably wrong, any apparent duplicity is probably spurious). This is normally due to failed matching of objects from different plates in USNO-B.meta.code.qualshortnullableno_sc1 if this object had no match within 3 arcseconds in SuperCosmos at J2000. It is very likely that it is not a real object. NOTE: False is encoded as NULL in the database; to exclude objects without a supercosmos match, write no_sc IS NULL.meta.code.qualshortnullable
icecubeIceCube-40 neutrino candidatesA list of neutrino candidate events recorded by the IceCube neutrino -telescope operating in a 40 string configuration between April 2008 -and May 2009.icecube.nucand Detection parameters of neutrino candidates recorded by the IceCube -Neutrino Observatory. This table can be queried on web at -http://dc.g-vo.org/icecube/q/web .12876evidGAVO-local event id, IAU-formatmeta.id;meta.maincharindexedprimarynualphaNeutrino arrival direction, RAdegpos.eq.ra;meta.mainfloatnudeltaNeutrino arrival direction, Declinationdegpos.eq.dec;meta.mainfloatmuelossEstimated muon energy loss in iceGeV/mphys.absorptionfloatmueEstimated muon energy at closest distance to the center of the IceCube detectorGeVphys.energyfloatnchNumber of optical modules hit in an eventmeta.numbershortmjdObservation time, Modified Julian Daytime.epoch;obsfloat
inflightThe Endless LightcurveThe infinite lightcurve is a continuously calculated microlensing -lightcurve, simulating the light variation of a quasar due to an -intervening star field.inflight.dataThe raw lensing data as well as relative intensities computed for -various source profiles.1200000lineDistance indicator in 0.01 Einstein radiipos.distanceintindexeddataBase64 encoded 8-bit image datacharnullablesrcnameName of file this line came frommeta.refcharnullablegauss01Magnification for a Gauss disk source with r=1magphot.mag;arith.difffloatnullablegauss02Magnification for a Gauss disk source with r=2magphot.mag;arith.difffloatnullablegauss04Magnification for a Gauss disk source with r=4magphot.mag;arith.difffloatnullablegauss06Magnification for a Gauss disk source with r=6magphot.mag;arith.difffloatnullablegauss08Magnification for a Gauss disk source with r=8magphot.mag;arith.difffloatnullablegauss10Magnification for a Gauss disk source with r=10magphot.mag;arith.difffloatnullablegauss12Magnification for a Gauss disk source with r=12magphot.mag;arith.difffloatnullablegauss16Magnification for a Gauss disk source with r=16magphot.mag;arith.difffloatnullablegauss20Magnification for a Gauss disk source with r=20magphot.mag;arith.difffloatnullablegauss24Magnification for a Gauss disk source with r=24magphot.mag;arith.difffloatnullablegauss28Magnification for a Gauss disk source with r=28magphot.mag;arith.difffloatnullablegauss32Magnification for a Gauss disk source with r=32magphot.mag;arith.difffloatnullablegauss40Magnification for a Gauss disk source with r=40magphot.mag;arith.difffloatnullablegauss48Magnification for a Gauss disk source with r=48magphot.mag;arith.difffloatnullablethin01Amplification of a thin disk of r=1magphot.mag;arith.diff;meta.mainfloatnullablethin02Magnification for thin disk with r=2magphot.mag;arith.difffloatnullablethin04Magnification for thin disk with r=4magphot.mag;arith.difffloatnullablethin06Magnification for thin disk with r=6magphot.mag;arith.difffloatnullablethin08Magnification for thin disk with r=8magphot.mag;arith.difffloatnullablethin10Magnification for thin disk with r=10magphot.mag;arith.difffloatnullablethin12Magnification for thin disk with r=12magphot.mag;arith.difffloatnullablethin16Magnification for thin disk with r=16magphot.mag;arith.difffloatnullablethin20Magnification for thin disk with r=20magphot.mag;arith.difffloatnullablethin24Magnification for thin disk with r=24magphot.mag;arith.difffloatnullablethin28Magnification for thin disk with r=28magphot.mag;arith.difffloatnullable
ivoaDefinition and support code for the ObsCore data model and table.ivoa.obs_radioAn IVOA-defined metadata table for radio measurements, with extra -metadata for interferometric measurements ("visibilities") as well as -single-dish observations. You will almost always want to join this -table to ivoa.obscore (do a natural join).ivo://ivoa.net/std/obsradio#table-1.0obs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexedprimarys_resolution_minAngular resolution, longest baseline and max frequency dependentarcsecpos.angResolution;stat.minChar.SpatialAxis.Resolution.Bounds.Limits.LoLimfloatnullables_resolution_maxAngular resolution, longest baseline and min frequency dependentarcsecpos.angResolution;stat.maxChar.SpatialAxis.Resolution.Bounds.Limits.HiLimfloatnullables_fov_minField of view diameter, min value, max frequency dependentdegphys.angSize;instr.fov;stat.minChar.SpatialAxis.Coverage.Bounds.Extent.LowLimfloatnullables_fov_maxField of view diameter, max value, min frequency dependentdegphys.angSize;instr.fov;stat.maxChar.SpatialAxis.Coverage.Bounds.Extent.HiLimfloatnullables_maximum_angular_scaleMaximum scale in dataset, shortest baseline and frequency dependentarcsecphys.angSize;stat.maxChar.SpatialAxis.Resolution.Scale.Limits.HiLimfloatnullablef_resolutionAbsolute spectral resolution in frequencykHzem.freq;stat.maxChar.SpectralAxis.Coverage.BoundsLimits.HiLimfloatnullablet_exp_minMinimum integration time per samplestime.duration;obs.exposure;stat.minChar.TimeAxis.Sampling.ExtentLoLimfloatnullablet_exp_maxMaximum integration time per samplestime.duration;obs.exposure;stat.maxChar.TimeAxis.Sampling.ExtentHiLimfloatnullablet_exp_meanAverage integration time per samplestime.duration;obs.exposure;stat.meanChar.TimeAxis.Sampling.ExtentHiLimfloatnullableuv_distance_minMinimal distance in uv planemstat.fourier;pos;stat.minChar.UVAxis.Coverage.Bounds.Limits.LoLimfloatnullableuv_distance_maxMaximal distance in uv planemstat.fourier;pos;stat.maxChar.UVAxis.Coverage.Bounds.Limits.LoLimfloatnullableuv_distribution_eccEccentricity of uv distributionstat.fourier;posChar.UVAxis.Coverage.Bounds.Eccentricityfloatnullableuv_distribution_fillFilling factor of uv distributionstat.fourier;pos;arith.ratioChar.UVAxis.Coverage.Bounds.FillingFactorfloatnullableinstrument_ant_numberNumber of antennas in arraymeta.number;instr.paramProvenance.ObsConfig.Instrument.Array.AntNumberfloatnullableinstrument_ant_min_distMinimum distance between antennas in arrayminstr.baseline;stat.minProvenance.ObsConfig.Instrument.Array.MinDistfloatnullableinstrument_ant_max_distMaximum distance between antennas in arrayminstr.baseline;stat.maxProvenance.ObsConfig.Instrument.Array.MaxDistfloatnullableinstrument_ant_diameterDiameter of telecope or antennas in arrayminstr.paramProvenance.ObsConfig.Instrument.Array.Diameterfloatnullableinstrument_feedNumber of feedsinstr.paramProvenance.ObsConfig.Instrument.Feedfloatnullablescan_modeScan mode (on-off, raster map, on-the-fly map,...)instr.paramProvenance.Observation.sky_scan_modefloatnullabletracking_modeTargeted, alt-azimuth, wobble, ...)instr.paramProvenance.Observation.tracking_modefloatnullableivoa.obscoreobs_publisher_didobs_publisher_did
ivoa.obscoreGAVO Data Center Obscore TableThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter.ivo://ivoa.net/std/obscore#table-1.184947229dataproduct_typeHigh level scientific classification of the data product, taken from an enumerationmeta.code.classobscore:obsdataset.dataproducttypecharnullabledataproduct_subtypeData product specific typemeta.code.classobscore:obsdataset.dataproductsubtypecharnullablecalib_levelAmount of data processing that has been applied to the datameta.code;obs.calibobscore:obsdataset.caliblevelshortobs_collectionName of a data collection (e.g., project name) this data belongs tometa.idobscore:dataid.collectioncharnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharindexednullableobs_creator_didDataset identifier assigned by the creator.meta.idobscore:dataid.creatordidcharnullableaccess_urlThe URL at which to obtain the data set.meta.ref.urlobscore:access.referencecharnullableaccess_formatMIME type of the resource at access_urlmeta.code.mimeobscore:access.formatcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullabletarget_classClass of the target object (star, QSO, ...)src.classobscore:target.classcharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doubleindexednullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doubleindexednullables_fovApproximate spatial extent for the region covered by the observationdegphys.angSize;instr.fovobscore:char.spatialaxis.coverage.bounds.extent.diameterdoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_resolutionBest spatial resolution within the data setarcsecpos.angResolutionobscore:Char.SpatialAxis.Resolution.refval.valuedoublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_resolutionMinimal significant time interval along the time axisstime.resolutionobscore:char.timeaxis.resolution.refval.valuefloatnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullableem_res_powerSpectral resolving power lambda/delta lambdaspect.resolutionobscore:char.spectralaxis.resolution.resolpower.refvaldoublenullableo_ucdUCD for the product's observablemeta.ucdobscore:char.observableaxis.ucdcharnullablepol_statesList of polarization states in the data setmeta.code;phys.polarizationobscore:Char.PolarizationAxis.stateListcharnullablefacility_nameName of the facility at which data was takenmeta.id;instr.telobscore:Provenance.ObsConfig.facility.namecharnullableinstrument_nameName of the instrument that produced the datameta.id;instrobscore:Provenance.ObsConfig.instrument.namecharnullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullablet_xelNumber of elements (typically pixels) along the time axis.meta.numberobscore:Char.TimeAxis.numBinslongnullableem_xelNumber of elements (typically pixels) along the spectral axis.meta.numberobscore:Char.SpectralAxis.numBinslongnullablepol_xelNumber of elements (typically pixels) along the polarization axis.meta.numberobscore:Char.PolarizationAxis.numBinslongnullables_pixel_scaleSampling period in world coordinate units along the spatial axisarcsecphys.angSize;instr.pixelobscore:Char.SpatialAxis.Sampling.RefVal.SamplingPerioddoublenullableem_ucdNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)meta.ucdobscore:Char.SpectralAxis.ucdcharnullablepreviewURL of a preview (low-resolution, quick-to-retrieve representation) of the data.meta.ref.url;meta.previewcharnullablesource_tableName of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.meta.id;meta.tablecharnullable
k2c9vstCoordinated microlensing survey observations with Kepler K2/C9 using -VST The Kepler satellite has observed the Galactic center in a campaign -lasting from April until the end of June 2016 (K2/C9). The main -objective of the 99 hours for the microlensing program 097.C-0261(A) -using the ESO VLT Survey Telescope (VST) was to monitor the superstamp -(i.e., the actually downloaded region of K2/C9) in service mode for -improving the event coverage and securing some color-information. Due -to weather conditions, the majority of images were taken in the red -band. These are part of the present release. - -The exact pointing strategy was adjusted to cover the superstamp with -6 pointings and to contain as many microlensing events from earlier -seasons as possible. In addition, a two-point dither was requested to -reduce the impact of bad pixels and detector gaps. Consequently, some -events were getting more coverage and have been observed with -different CCDs. The large footprint of roughly 1 square degree and the -complementary weather conditions at Cerro Paranal have lead to the -coverage of 147 events (this resource's events table), but ~60 of -those were already at baseline.k2c9vst.eventsK2/C9 Microlensing Events The Kepler satellite has observed the Galactic center in a campaign -lasting from April until the end of June 2016 (K2/C9). The main -objective of the 99 hours for the microlensing program 097.C-0261(A) -using the ESO VLT Survey Telescope (VST) was to monitor the superstamp -(i.e., the actually downloaded region of K2/C9) in service mode for -improving the event coverage and securing some color-information. Due -to weather conditions, the majority of images were taken in the red -band. These are part of the present release. - -The exact pointing strategy was adjusted to cover the superstamp with -6 pointings and to contain as many microlensing events from earlier -seasons as possible. In addition, a two-point dither was requested to -reduce the impact of bad pixels and detector gaps. Consequently, some -events were getting more coverage and have been observed with -different CCDs. The large footprint of roughly 1 square degree and the -complementary weather conditions at Cerro Paranal have lead to the -coverage of 147 events (this resource's events table), but ~60 of -those were already at baseline.725event_idEvent name as specified by OGLE (http://ogle.astrouw.edu.pl/ogle4/ews/2015/ews.html) or MOA (http://www.phys.canterbury.ac.nz/moa/). Some event ids actually reference the same object. These have otherwise identical records.meta.id;meta.maincharindexedprimaryraj2000Right ascension of the event source as reported by the OGLE or MOAdegpos.eq.ra;meta.maindoublenullabledej2000Right ascension of the event source as reported by the OGLE or MOAdegpos.eq.dec;meta.maindoublenullablet_alertHJD of alert release.dtime.releasedoublenullablet_0Time of largest magnification estimated from a fit assuming a gravitational lens event of pointlike source and lens.dtime.duration;stat.fitdoublenullablet_eEvent timescale (Einstein time assuming a gravitational lens event of pointlike source and lens).dtime.durationdoublenullableu_0Impact parameter in units of Einstein radii.src.impactParamfloatnullablea_0Maximum magnification.phot.flux;arith.ratiofloatnullableflagsBitmask for flags: bit 0 -- during campaign; bit 1: In footprint (i.e., Kepler data could be available); bit 2: In superstamp (i.e., Kepler data available).meta.codeshort
k2c9vst.photpointsPhotometric Points Obtained by K2/C9 followup The Kepler satellite has observed the Galactic center in a campaign -lasting from April until the end of June 2016 (K2/C9). The main -objective of the 99 hours for the microlensing program 097.C-0261(A) -using the ESO VLT Survey Telescope (VST) was to monitor the superstamp -(i.e., the actually downloaded region of K2/C9) in service mode for -improving the event coverage and securing some color-information. Due -to weather conditions, the majority of images were taken in the red -band. These are part of the present release. - -The exact pointing strategy was adjusted to cover the superstamp with -6 pointings and to contain as many microlensing events from earlier -seasons as possible. In addition, a two-point dither was requested to -reduce the impact of bad pixels and detector gaps. Consequently, some -events were getting more coverage and have been observed with -different CCDs. The large footprint of roughly 1 square degree and the -complementary weather conditions at Cerro Paranal have lead to the -coverage of 147 events (this resource's events table), but ~60 of -those were already at baseline.9384accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullabledidLocal dataset identifier for the lightcurve this point belongs to.meta.id;meta.maincharindexednullableevent_idAssociated Eventcharnullableobs_timeTime this photometry corresponds to.dtime.epochdoublenullablephotSDSS r-band instrumental magnitude (warning: zeropoint may be off several mag).magphot.mag;em.opt.RdoublenullableimageVST image this point was taken from. The raw images are available at http://archive.eso.org/wdb/wdb/eso/eso_archive_main/query?prog_id=097.C-0261(A)meta.ref;meta.filecharnullabledfDifference flux as defined by 2008MNRAS.386L..77Baduphot.fluxdoublenullablee_dfError in difference flux.adustat.error;phot.fluxfloatnullablerfReference flux as defined by 2008MNRAS.386L..77Baduphot.fluxdoublenullablee_rfError in reference Fluxadustat.error;phot.fluxfloatnullablee_photError in SDSS r-band instrumental magnitude.magstat.error;phot.magfloatnullableexp_timeExposure time.stime.duration;obs.exposurefloatnullablefwhmFWHM of the point spread function averaged over all stars on the subimage used.arcsecphys.angSize;instr.det.psffloatnullablesky_backgroundMedian sky background flux.aduinstr.backgroundfloatnullablephot_scale_factorScale factor according to 2008MNRAS.386L..77B; if small, photometry was obtained under suboptimal atmospheric transparency.floatnullablechi2_pxSee 2008MNRAS.386L..77B, sect. 2.1stat.fit.chi2floatnullabledxPixel offset of frame wrt. the reference frame, x directionpixelpos.cartesian.x;arith.difffloatnullabledyPixel offset of frame wrt. the reference frame, y directionpixelpos.cartesian.y;arith.difffloatnullablecorr_coeffCoefficients of correction polynomial for frame: TBDfloatnullablek2c9vst.eventsevent_idevent_id
k2c9vst.timeseries The Kepler satellite has observed the Galactic center in a campaign -lasting from April until the end of June 2016 (K2/C9). The main -objective of the 99 hours for the microlensing program 097.C-0261(A) -using the ESO VLT Survey Telescope (VST) was to monitor the superstamp -(i.e., the actually downloaded region of K2/C9) in service mode for -improving the event coverage and securing some color-information. Due -to weather conditions, the majority of images were taken in the red -band. These are part of the present release. - -The exact pointing strategy was adjusted to cover the superstamp with -6 pointings and to contain as many microlensing events from earlier -seasons as possible. In addition, a two-point dither was requested to -reduce the impact of bad pixels and detector gaps. Consequently, some -events were getting more coverage and have been observed with -different CCDs. The large footprint of roughly 1 square degree and the -complementary weather conditions at Cerro Paranal have lead to the -coverage of 147 events (this resource's events table), but ~60 of -those were already at baseline.119accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharnullablessa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxadustat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxadustat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablet_min_mjd(Approximate) earliest timestamp in dataset.dtime.start;obsts:time.startdoubleindexednullablet_max_mjd(Approximate) latest timestamp in dataset.dtime.end;obsts:time.enddoubleindexednullablet_0Time of largest magnification estimated from a fit assuming a gravitational lens event of pointlike source and lens.dtime.duration;stat.fitdoublenullable
kapteynPotsdam Kapteyn Series Plates -In the context of Kapteyn's plan to obtain a photometric standard, in -Potsdam more than 400 photographic plates of several Selected Areas, -Special Areas, and Kapteyn-Pritchard areas were obtained between 1910 and -1933, both as direct images and with an object prism. This service -provides FITS images of the science area of the plates as well as images of -the entire plates, including previous markings.kapteyn.plates -In the context of Kapteyn's plan to obtain a photometric standard, in -Potsdam more than 400 photographic plates of several Selected Areas, -Special Areas, and Kapteyn-Pritchard areas were obtained between 1910 and -1933, both as direct images and with an object prism. This service -provides FITS images of the science area of the plates as well as images of -the entire plates, including previous markings.374accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableexposureEffective exposure time.stime.duration;obs.exposurefloatnullableairmassAirmass at mean epoch.obs.airMassfloatnullableobjectSpecial object on plate.meta.idcharnullableobserverObserver.obs.observercharnullablestart_timeUT at start of exposure.dtime.start;obscharnullableend_timeUT at end of exposure.dtime.end;obscharnullablewfpdb_idPlate identifier as in the WFPDB.meta.idcharnullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharnullableplatephotoImage of the plate including border and other markings.meta.ref.urlcharnullable
katkatARI Catalog of Catalogs -ARI katkat is a catalog of star catalogues -in the spirit of G. Teleki's catalog of star catalogs -(`1989BOBeo.140..131T`_ and references in there). It contains -2573 catalogs suitable for astrometric usage, starting with Flamsteed -(1835) and ending in the 1970ies. For almost all of them, there -is a column description file (as PDF, and unfortunately sometimes in -German) and the digitized content. - -.. _1989BOBeo.140..131T: http://ads.g-vo.org/abs/1989BOBeo.140..131Tkatkat.katkatThe "catalog of catalogs" lists catalogs containing stellar positions -for the last centuries. It also lets you access digitized table -data.2573fileidARI-internal file identifiermeta.id;meta.maincharindexedprimarykkidARIGFH identifier of the tablemeta.idcharnullabletelekiTeleki number of the catalogmeta.idintnullablehdwlHDWL number of the catalogmeta.idcharnullablenrowsNumber of rows (i.e., lines) in the catalogmeta.numberintnullablenidNumber of objects that could be matched with the ARIGFH mastermeta.numberintnullablesourceBibliographical information for the catalog.meta.refcharindexednullableremarksRemarks, e.g., on the identification process or where to find media (typically not interesting outside ARI).meta.notecharnullableminepochEarliest epoch of observation (approximate)yrtime.epoch;stat.minfloatnullablemaxepochLatest epoch of observation (approximate)yrtime.epoch;stat.maxfloatnullablekatdataRelative path to the data file (see table description to obtain the data if this is not a complete URLcharnullablekatfieldsURL of a PDF containing the field description (see table description to obtain the data if this is not a complete URLcharnullableliesfPainful FORTRAN used to parse the raw textcharnullable
lamost5LAMOST DR5 survey spectra -This services provides 1D spectra from DR5 of LAMOST (Large Sky Area -Multi-Object Fiber Spectroscopic Telescope) through SSAP and Obscore; -data is served both in VO-standard SDM and, via datalink, the original -SDSS-inspired FITS described in -http://dr5.lamost.org/doc/data-production-description .lamost5.data -This services provides 1D spectra from DR5 of LAMOST (Large Sky Area -Multi-Object Fiber Spectroscopic Telescope) through SSAP and Obscore; -data is served both in VO-standard SDM and, via datalink, the original -SDSS-inspired FITS described in -http://dr5.lamost.org/doc/data-production-description .9100000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullableraj2000Observed RA of the objectdegpos.eq.ra;meta.maindoublenullabledej2000Main value of declinationdegpos.eq.dec;meta.maindoublenullablessa_targsubclassObject subclasscharnullable
lamost6LAMOST DR6 Spectra LAMOST, the The Large Sky Area Multi-Object Fiber Spectroscopic -Telescope (or Guoshoujing Telescope) is an instrument tailored for -producing large number of optical medium- and low-resolution spectra. -Here, we publish both the medium (MRS) and low (LRS) resolution -spectra from Data Release 6, http://dr6.lamost.org/v2/, to the Virtual -Observatory.lamost6.ssa_lrsSSA-compliant metadata for LAMOST DR6 low resolution spectra; this -data is also availble through Obscore; the collection name there is -LAMOST6 LRS.10000000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift as estimated by the LAMOST pipeline.src.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablez_errError in ssa_redshift as estimated by the LAMOST pipeline.stat.error;src.redshiftfloatnullable
lamost6.ssa_mrsSSA-compliant metadata for LAMOST DR6 medium resolution spectra; this -data is also availble through Obscore; the collection name there is -LAMOST6 MRS.5900000accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrMedian signal to noise ratio over all pixel, computed as flux/sqrt(variance)stat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.ResolutionfloatnullablemobsidUnique identifier for the medium resolution spectrum (most of these have multiple observations and include a coadded spectrum).meta.id;meta.maincharssa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullableobsidUnique identifier for the observation; LAMOST observations typically result in multiple spectra.meta.id;obslongdesignationTarget Designation (IAU style)meta.idcharnullableplanidIdentifier of the observation planmeta.id;obs.proposalcharnullablespidIdentifier of the Spectragraph that took the source spectrum.meta.id;instrshortfiberidIdentifier of the fiber used to take the source spectrummeta.id;instrshortra_obsICRS right ascension of the fiber pointing (can be different from ra for bright sources).degpos.eq.radoublenullabledec_obsICRS declination of the fiber pointingdegpos.eq.decdoublenullableobjtypeObject type: star, k2star, fs, rvcandi, galmeta.code.classcharnullablemagtypeDesignation of the bands of the magnitudes in mag_arr; this is not easy to parse by a machine, sorry.meta.codecharnullablemag_arrAn array of derived magnitudes. See mag_types for the bands these magnitudes are intended for.phot.magfloatnullablefibertypeFiber Type of target (one of Obj, Sky, F-std, Unused, PosErr, Dead)meta.code;instrcharnullabletarget_commentVarious comments (e.g., an external target id).meta.notecharnullableoffset_vOffset of the observation from the target coordinate (these are added for bright objects to prevent saturation).arcsecinstr.offsetfloatnullableraICRS right ascension for this object from input cataloguedegpos.eq.ra;meta.maindoublenullabledecICRS declination for this object from input cataloguedegpos.eq.dec;meta.maindoublenullablerv_b0Radial velocity estimated from the B spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_b0_errError in rv_b0.km/sstat.error;spect.dopplerVelocfloatnullablerv_r0Radial velocity estimated from the R spectrum after continuum removal.km/sspect.dopplerVelocfloatnullablerv_r0_errError in rv_r0.km/sstat.error;spect.dopplerVelocfloatnullablerv_br0Radial velocity estimated from the B and R spectra after continuum removal.km/sspect.dopplerVelocfloatnullablerv_br0_errError in rv_br0.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp0Radial velocity estimated from the LAMOST stellar parameter pipeline.km/sspect.dopplerVelocfloatnullablerv_lasp0_errError in rv_lasp0.km/sstat.error;spect.dopplerVelocfloatnullablerv_b1rv_b0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_b1_errError in rv_b1.km/sstat.error;spect.dopplerVelocfloatnullablerv_r1rv_r0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_r1_errError in rv_r1.km/sstat.error;spect.dopplerVelocfloatnullablerv_br1rv_br0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_br1_errError in rv_br1.km/sstat.error;spect.dopplerVelocfloatnullablerv_lasp1rv_lasp0 after zero-point correctionkm/sspect.dopplerVelocfloatnullablerv_lasp1_errError in rv_lasp1.km/sstat.error;spect.dopplerVelocfloatnullablerv_b_flagFlag for RV extraction in the b band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_r_flagFlag for RV extraction in the r band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortrv_br_flagFlag for RV extraction in the br band: 0 – no anomalies; 1 – too many bad pixels; 2 – radial velocity in excess of 450 km/s; 3 – low similarity with best-matched template.meta.code.qualshortcoadd1 if this is a co-added spectrummeta.codeshortfibermaskBitmask for fiber problems. See note for the meaning for the bits.meta.code.qualshortbad_b1 if this is a problematic B spectrum.meta.codeshortbad_r1 if this is a problematic R spectrum.meta.codeshort
life_tdThe LIFE Target Star Database LIFETD -The LIFE Target Star Database contains information useful -for the planned `LIFE mission`_ (mid-ir, nulling -interferometer in space). It characterizes possible -target systems including information about stellar, -planetary and disk properties. The data itself is mainly -a collection from different other catalogs. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. - - -.. _LIFE mission: https://life-space-mission.com/life_td.disk_basicBasic disk parameters A list of all basic disk parameters. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -33object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryrad_valueBlack body radius.AUphys.size.radiusdoublenullablerad_errRadius errorAUstat.error;phys.size.radiusdoublenullablerad_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullablerad_relRadius relation defining upper / lower limit or exact measurement through '<' ,'>', and '='.phys.size.radius;arith.ratiocharnullablerad_source_idrefIdentifier of the source of the disk parameters.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.h_linkObject relation table This table links subordinate objects (e.g. a planets of a star, or a -star in a multiple star system) to their parent objects. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -846parent_object_idrefObject key (unstable, use only for joining to the other tables).meta.id.parent;meta.mainintindexedprimarychild_object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimarymembershipMembership probability.meta.recordintnullableh_link_source_idrefIdentifier of the source of the relationship parameters.meta.refintindexedprimary
life_td.identObject identifiers table A list of the object identifiers. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -63295object_idrefObject key (unstable, use only for joining to the other tables).meta.idintindexedprimaryidObject identifier.meta.idcharindexedprimaryid_source_idrefIdentifier of the source of the identifier parameter.meta.refintindexedprimary
life_td.mes_binaryMultiplicitz measurement table A list of the stellar multiplicitz measurements. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarybinary_flagBinary flag.meta.code.multipcharindexedprimarybinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_mass_plMass measurement table A list of the planetary mass measurements. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_mass_stMass measurement table A list of the stellar mass measurements. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_radius_stRadius measurement table A list of the stellar radius measurements. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintindexedprimarylife_td.objectobject_idrefobject_id
life_td.mes_sep_angPhys. separation measurement table A list of the stellar phys. separation measurements. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintsep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
life_td.mes_teff_stEffective temperature measurement table A list of the stellar effective temperature measurements. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimaryteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintindexedprimarylife_td.objectobject_idrefobject_id
life_td.objectObject table A list of the astrophysical objects. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -3672object_idObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarytypeObject type (sy=multi-object system, st=star, pl=planet and di=disk).src.classcharnullablemain_idMain object identifier.meta.idcharidsAll identifiers of the object separated by '|'.meta.idchar
life_td.planet_basicBasic planetary parameters A list of all basic planetary parameters. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -502object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarymass_pl_valueMass'jupiterMass'phys.massdoublenullablemass_pl_errMass error'jupiterMass'stat.error;phys.massdoublenullablemass_pl_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_pl_relMass relation defining upper / lower limit or exact measurement through '<', '>', and '='.phys.mass;arith.ratiocharnullablemass_pl_source_idrefIdentifier of the source of the mass parameter.meta.refintnullablelife_td.objectobject_idrefobject_id
life_td.providerProvider Table A list of all the providers for the parameters in the other tables. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -provider_nameName for the service through which the data was acquired.meta.bib.authorcharindexedprimaryprovider_urlService through which the data was acquired.meta.ref.urlcharnullableprovider_bibcodeReference, bibcode if possible.meta.refcharnullableprovider_accessDate of access to provider.timecharnullable
life_td.sourceSource Table A list of all the sources for the parameters in the other tables. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -281source_idSource identifier.meta.idintindexedprimaryrefReference, bibcode if possible.meta.refcharnullableprovider_nameName for the service through which the data was acquired. SIMBAD: service = http://simbad.u-strasbg.fr:80/simbad/sim-tap, bibcode = 2000A&AS..143....9W. ExoMercat: service = http://archives.ia2.inaf.it/vo/tap/projects, bibcode = 2020A&C....3100370A. Everything else is acquired through private communication.meta.bib.authorchar
life_td.star_basicBasic stellar parameters A list of all basic stellar parameters. - -Note that LIFE's target database is living -data. The content – and to some extent even structure – of these -tables may change at any time without prior warning. -3137object_idrefObject key (unstable, use only for joining to the other tables).meta.id;meta.mainintindexedprimarycoo_raRight Ascensiondegpos.eq.ra;meta.maindoubleindexednullablecoo_decDeclinationdegpos.eq.dec;meta.maindoubleindexednullablecoo_err_angleCoordinate error angledegpos.posAng;pos.errorEllipse;pos.eqshortnullablecoo_err_majCoordinate error major axismasphys.angSize.smajAxis;pos.errorEllipse;pos.eqfloatnullablecoo_err_minCoordinate error minor axismasphys.angSize.sminAxis;pos.errorEllipse;pos.eqfloatnullablecoo_qualCoordinate quality (A:best, E:worst)meta.code.qual;pos.eqcharnullablecoo_source_idrefSource identifier corresponding to the position (coo) parameters.meta.refintnullablecoo_gal_lGalactical longitude.degpos.galactic.londoublenullablecoo_gal_bGalactical latitude.degpos.galactic.latdoublenullablecoo_gal_source_idrefSource identifier corresponding to the position (coo_gal) parameters.meta.refintnullablemag_i_valueMagnitude in I filter.phot.mag;em.opt.Idoublenullablemag_i_source_idrefSource identifier corresponding to the Magnitude in I filter parameters.meta.refintnullablemag_j_valueMagnitude in J filter.phot.mag;em.IR.Jdoublenullablemag_j_source_idrefSource identifier corresponding to the Magnitude in J filter parameters.meta.refintnullablemag_k_valueMagnitude in K filter.phot.mag;em.IR.Kdoublenullablemag_k_source_idrefSource identifier corresponding to the Magnitude in K filter parameters.meta.refintnullableplx_valueParallax value.maspos.parallaxdoublenullableplx_errParallax uncertainty.masstat.error;pos.parallaxdoublenullableplx_qualParallax quality (A:best, E:worst)meta.code.qual;pos.parallaxcharnullableplx_source_idrefSource identifier corresponding to the parallax parameters.meta.refintnullabledist_st_valueObject distance.pcpos.distancedoublenullabledist_st_errObject distance error.pcstat.error;pos.distancedoublenullabledist_st_qualDistance quality (A:best, E:worst)meta.code.qual;pos.distancecharnullabledist_st_source_idrefIdentifier of the source of the distance parameter.meta.refintnullablesptype_stringObject spectral type MK.src.spTypecharnullablesptype_errObject spectral type MK error.stat.error;src.spTypedoublenullablesptype_qualSpectral type MK quality (A:best, E:worst)meta.code.qual;src.spTypecharnullablesptype_source_idrefIdentifier of the source of the spectral type MK parameter.meta.ref;src.spTypeintnullableclass_tempObject spectral type MK temperature class.src.spTypecharnullableclass_temp_nrObject spectral type MK temperature class number.src.spTypecharnullableclass_lumObject spectral type MK luminosity class.src.spTypecharnullableclass_source_idrefIdentifier of the source of the spectral type MK classification parameter.meta.ref;src.spTypeintnullableteff_st_valueObject effective temperature.Kphys.temperature.effectivedoublenullableteff_st_errObject effective temperature error.Kstat.error;phys.temperature.effectivedoublenullableteff_st_qualEffective temperature quality (A:best, E:worst)meta.code.qual;phys.temperature.effectivecharnullableteff_st_source_idrefIdentifier of the source of the effective temperature parameter.meta.ref;phys.temperature.effectiveintnullableradius_st_valueObject radius.solRadphys.size.radiusdoublenullableradius_st_errObject radius error.solRadstat.error;phys.size.radiusdoublenullableradius_st_qualRadius quality (A:best, E:worst)meta.code.qual;phys.size.radiuscharnullableradius_st_source_idrefIdentifier of the source of the radius parameter.meta.ref;phys.size.radiusintnullablemass_st_valueObject mass.solMassphys.massdoublenullablemass_st_errObject mass error.solMassstat.error;phys.massdoublenullablemass_st_qualMass quality (A:best, E:worst)meta.code.qual;phys.masscharnullablemass_st_source_idrefIdentifier of the source of the mass parameter.meta.ref;phys.massintnullablebinary_flagBinary flag.meta.code.multipcharnullablebinary_qualBinary quality (A:best, E:worst)meta.code.qualcharnullablebinary_source_idrefIdentifier of the source of the binary_flag parameter.meta.refintnullablesep_ang_valueAngular separation of binary.arcsecpos.angDistancedoublenullablesep_ang_errObject ang. separation error.arcsecstat.error;pos.angDistancedoublenullablesep_ang_obs_dateYear of observation.time.epoch;obsintnullablesep_ang_qualAng. separation quality (A:best, E:worst)meta.code.qual;pos.angDistancecharnullablesep_ang_source_idrefIdentifier of the source of the sep_ang parameter.meta.ref;pos.angDistanceintnullablelife_td.objectobject_idrefobject_id
lightmeterLightmeter Data We give continuous night and day light measurements at all natural -outdoor light levels by a network of low-cost lightmeters. Developed -to start simple, global continuous high cadence monitoring of night -sky brightness and artificial night sky brightening (light pollution) -in 2009. The lightmeter network is a project of the Thüringer -Landessternwarte, Tautenburg, Germany and the Kuffner-Sternwarte -society at the Kuffner-Observatory, Vienna, Austria. - -It started as part of the Dark Skies Awareness cornerstone of the -International Year of Astronomy.lightmeter.geocountsLightmeter data by date and geographic positionepochJD of measurement, UTCdtime.epochdoublestationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharlatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullablefluxCalibrated fluxW.m**-2phot.fluxfloat
lightmeter.measurementsTime-averaged lightmeter measurements3400000stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedepochJD of measurement, UTCdtime.epochdoubleindexedfluxCalibrated fluxW.m**-2phot.fluxfloats_fluxStandard deviation of light measurements contributing to this averageW.m**-2stat.stdev;phot.fluxfloatnullablenvalsNumber of measurements contributing to this valuemeta.number;obsintsourceSource file keymeta.id;meta.filecharnullable
lightmeter.stationsStations in the lightmeter network44stationidIdentifier of the measuring station, starting with an ISO CCmeta.id;meta.maincharindexedprimarylatLatitude of the observing stationdegpos.earth.latdoublenullablelongLongitude of the observing stationdegpos.earth.londoublenullableheightHeight above sea levelmpos.earth.altitudefloatnullablefullnameFull name of the stationmeta.idchardevtypeDevice type (as in: IYA Lightmeter, SQM, ...)meta.code;instrcharnullabletimecorrectionSeconds to add to this stations reported times to obtain UTCintnullablecalibaCalibration parameter, ainstr.calibfloatnullablecalibbCalibration parameter, binstr.calibfloatnullablecalibcCalibration parameter, cW.m**-2instr.calibfloatnullablecalibdCalibration parameter, dK**-1instr.calibfloatnullable
liverpoolLiverpool Quasar Lens MonitoringThis collection includes optical monitorings of gravitationally lensed -quasars. The frames can be used to make light curves of quasar images -and field objects. From quasar light curves, one may measure time -delays and flux ratios, analyse variability and chromaticity, etc. -These direct analyses/measurements are basic tools for different -astrophysical studies, e.g., expansion rate of the Universe, mechanism -of intrinsic variability in quasars, accretion disk structure, -supermassive black holes, dark halos of galaxies (dust, collapsed dark -matter, smoothly distributed dark matter,...)liverpool.rawframesThis collection includes optical monitorings of gravitationally lensed -quasars. The frames can be used to make light curves of quasar images -and field objects. From quasar light curves, one may measure time -delays and flux ratios, analyse variability and chromaticity, etc. -These direct analyses/measurements are basic tools for different -astrophysical studies, e.g., expansion rate of the Universe, mechanism -of intrinsic variability in quasars, accretion disk structure, -supermassive black holes, dark halos of galaxies (dust, collapsed dark -matter, smoothly distributed dark matter,...)561accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablecreation_dateDate of FITS file creationdtime.creationcharnullabletypeType of the observation (Science, Flat...)meta.code.classcharobjectObject observed, Simbad resolvable identifiermeta.idcharnullableraw_objectObject observed as given in the headermeta.idcharnullableobservatoryObservatory of origin for this framemeta.id;instr.obstycharnullabletelescopeTelescope used to obtain the frameinstr.telcharnullableinstrumentIdentifier of the originating instrumentcharnullabledetectorDetector usedmeta.id;instrcharnullableexposureExposure timestime.duration;obs.exposurefloatnullableairmassAir mass at center of observationobs.airMassfloatnullablemoonfracFraction of illuminated area of the moon at obs. timeobs.param;arith.ratiofloatnullablemoondistLunar distance from targetdegpos.angDistancefloatnullablel1satIs the brightest object in the field saturated?instr.saturation;stat.maxbooleanbackgroundBackground in countsct.s**-1instr.backgroundfloatnullableseeingEstimate for seeing at observation timearcsecinstr.obsty.seeingfloatnullablestarttimeUT at start of observationtime.startcharnullable
lotsspol Rotation Measures from the LOFAR Two Meter Sky Survey LoTSS DR2 -The LOFAR Two Meter Sky Survey LoTSS DR2 -(:bibcode:`2022A&A...659A...1S`) obtained radio data from 27% of the -northern sky between 120 and 168 MHz in the year 2014 through 2020. This -service publishes polarization spectra of extragalactic radio sources -(radio galaxies and blazars) and the rotation measures derived from them. -We also give redshifts for all sources. The data has a spatial resolution -of 20 arcsec.lotsspol.rmtableA table of rotation measures derived -from the content of lotsspol.spectra. This is supposed to be in line with -RMTable version 1, https://github.com/CIRADA-Tools/RMTable.2461cat_idSource ID in catalogmeta.id;meta.mainshortraRight Ascension [ICRS] of the polarised emission at epoch (this will often be an one extremity of the radio source).degpos.eq.ra;meta.maindoublenullabledecDeclination [ICRS] of the polarised emission at epoch (this will often be an one extremity of the radio source).degpos.eq.dec;meta.maindoublenullabledatalinkDatalink for the spectrummeta.ref.urlcharnullablermRotation measurerad.m**-2phys.polarization.rotMeasure;meta.mainfloatnullablerm_errTotal error in RMrad.m**-2stat.error;phys.polarization.rotMeasuredoublenullablerm_err_snrError in RM from signal to noise ratio onlyrad.m**-2stat.error;phys.polarization.rotMeasuredoublenullablepolintPolarized intensityJyphot.flux.density;phys.polarization.lineardoublenullablepolint_errError in Polarised IntensityJystat.error;phot.flux.density;phys.polarization.linearfloatnullablefracpolFractional (linear) polarizationphys.polarization.lineardoublenullablefracpol_errError in fractional polarizationstat.error;phys.polarization.linearfloatnullablermsf_fwhmFull-width at half maximum of the RMSFrad.m**-2instr.rmsf;stat.fwhmfloatnullablereffreq_polReference frequency for polarizationHzem.freq;phys.polarizationfloatnullablelGalactic Longitudedegpos.galactic.londoublenullablebGalactic Latitudedegpos.galactic.latdoublenullablepos_errPosition uncertaintydegstat.error;posdoublenullablebeamdistDistance from beam centre (taken as centre of tile)degpos.angDistance;instr.beamfloatnullablecatnameName of catalog this was taken from.meta.notecharnullablecomplex_flagFaraday complexity flagmeta.codecharnullablecomplex_testFaraday complexity metricmeta.notecharnullablerm_methodRM determination methodmeta.notecharnullableionosphereIonospheric correction methodmeta.notecharnullablepol_biasPolarization bias correction methodmeta.notecharnullableflux_typeStokes extraction methodmeta.notecharnullablebeam_majBeam major axisdegpos.angResolution;instr.beam;phys.angSize.smajAxisfloatnullablebeam_minBeam minor axisdegpos.angResolution;instr.beam;phys.angSize.sminAxisfloatnullablebeam_paBeam position angledegpos.angResolution;instr.beam;pos.posAngfloatnullablereffreq_beamReference frequency for beamHzem.freq;instr.beamfloatnullableminfreqLowest frequencyHzem.freq;stat.minfloatnullablemaxfreqHighest frequencyHzem.freq;stat.maxfloatnullablechannelwidthTypical channel widthHzem.freq;instr.bandwidthfloatnullablenoise_chanTypical per-channel noise in Q;UJystat.error;instr.det.noisefloatnullabletelescopeName of Telescope(s)instr.telcharnullableint_timeIntegration timestime.duration;obs.exposurefloatnullableepoch_mjdMedian epoch of observationdtime.epochdoublenullableobs_intervalInterval of observationdtime.intervalfloatnullableleakageInstrumental leakage estimatephys.polarization.linearfloatnullabledatarefData referencesmeta.bib.bibcodecharnullablenotesNotesmeta.notecharnullablereffreq_iReference frequency for Stokes IHzem.freq;phys.polarization.stokes.IfloatnullablefieldLoTSS observation pointing namemeta.id;obs.fieldcharnullablexx-pixel coordinate within an individual LoTSS field, ranging from 0 to 3200, for a pixel width of 4.5 arcsecpixelpos.cartesian.x;instr.detshortyy-pixel coordinate within an individual LoTSS field, ranging from 0 to 3200, for a pixel height of 4.5 arcsecpixelpos.cartesian.y;instr.detshortsnr_rmtools_madSignal to noise ratio based the peak polarized intensity divided by the estimated noise in the Faraday depth spectrum (where the noise is computed using the median deviation from the median of the polarized intensity, and then correcting to be equivalent to a Gaussian sigma).stat.snr;phot.flux;phys.polarizationdoublenullablera_nvssRA of the object in NVSSdegpos.eq.radoublenullabledec_nvssDec of the object in NVSSdegpos.eq.decdoublenullablenvss_rmRotation measure of the object in NVSSrad.m**-2phys.polarization.rotMeasurefloatnullablenvss_rm_errError in rotation measure of the object in NVSSrad.m**-2stat.error;phys.polarization.rotMeasurefloatnullablei_nvssIntegrated Stokes I flux density from NVSSmJyphot.flux;phys.polarization.stokes.Ifloatnullablep_nvssAverage peak polarized intensity from NVSSmJyphot.flux;phys.polarization.stokes.Ifloatnullablepi_nvssPercent polarization from NVSSphys.polarization;arith.ratiofloatnullableseparation_nvssDifference between NVSS position and LoTSS DR2 positionarcsecpos.angDistancedoublenullablelgz_sizeLargest angular size of the sourcearcsecphys.angsize;stat.maxdoublenullablezphotPhotometric redshift derived here from archive photometry (WISE, PanSTARRS, etc; cf. 2021A&A...648A...4D).src.redshift.photdoublenullablezphot_errError in zphotstat.error;src.redshift.photdoublenullablephot_spec_z_bestNature of z_best: 0: phot, 1: specmeta.code;src.redshiftshortlgz_ra_degRA of the host galaxy, mainly from NED.degpos.eq.radoublenullablelgz_dec_degDec of the host galaxy, mainly from NED.degpos.eq.decdoublenullablez_bestBest redshift available from the literature, typically from NED.src.redshiftdoublenullablenum_in_fieldNumber of polarized sources in the originating pointing.meta.number;srcshortmedrmMedian RM in the originating pointing.rad.m**-2phys.polarization.rotMeasure;stat.medianfloatnullablemadrmMedian absolute deviation of RM in the originating pointing.rad.m**-2stat.mad;phys.polarization.rotMeasurefloatnullablemedfpolMedian degree of polarization in the originating pointing (percent).phys.polarization;stat.medianfloatnullablemadfpolMedian absolute deviation of degree of polarization in the originating pointing (percent).stat.mad;phys.polarizationfloatnullablera_centreRA of field centredegpos.eq.ra;obs.fielddoublenullabledec_centreDec of field centredegpos.eq.dec;obs.fielddoublenullablenchanNumber of channels used in RM derivationmeta.number;em.binintnullablesource_name_dr2Official source name assigned by the International LOFAR Telescope ILT.meta.idcharnullablera_dr2LoTSS DR2 RA of the centroid of the total radio intensity using pyBDSF.degpos.eq.radoublenullabledec_dr2LoTSS DR2 Dec of the centroid of the total radio intensity using pyBDSF.degpos.eq.decdoublenullablee_ra_dr2Error in ra_dr2degstat.error;pos.eq.radoublenullablee_dec_dr2Error in dec_dr2degstat.error;pos.eq.decdoublenullabletotal_flux_dr2Total radio flux at 144 MHz from pyBDSF.Jyphot.flux;em.radiodoublenullablee_total_flux_dr2Error in total_flux_dr2Jystat.error;phot.flux;em.radiodoublenullablemaj_dr2Semimajor axis of the radio emissionarcsecphys.angSize.smajAxisdoublenullablemin_dr2Semiminor axis of the radio emissionarcsecphys.angSize.sminAxisdoublenullablepa_dr2Position angle of the radio emission, north over westdegpos.posAngdoublenullablel144Spectral luminosity at 144 MHz in the rest frame of the sourceW.Hz**-1phys.luminositydoublenullablelinearsize_kpcProjected largest linear sizekpcphys.sizedoublenullablerrmThe residual RM after subtraction of the average Galactic RM within an aperture of radius 1 degree (see the grm column).rad.m**-2phys.polarization.rotMeasure;src.netdoublenullablegrmAverage Galactic RM within an aperture of radius 1 degree from the Garching Faraday rotation sky v2.rad.m**-2phys.polarization.rotMeasuredoublenullablegrmerrError in grm.rad.m**-2stat.error;phys.polarization.rotMeasuredoublenullablebzcat_nameBlazar source name in the ROMA-BZCAT catalogue (2015Ap&SS.357...75M)meta.id.crosscharnullable
lotsspol.spectraSpectrally resolved polarisation; for pre-derived rotation measures, -see lotsspol.rmtable. The spectral behaviour of the LoTSS Stokes I data -are presently unreliable and not included here. However, one can use -the stokes_i column in lotsspol.rmtable in combination with an assumed -radio spectral index to produce fractional polarization spectra.2461ssa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.ClasscharnullableaccrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullablecat_idRunning number of the sourcemeta.id;meta.mainlongfreqThe spectral coordinateHzem.freqdoublenullablestokesiPer-frequency Stokes polarization coefficients ImJy/beamphys.polarization.stokes.Idoublenullablestokesi_errorError in stokesimJy/beamstat.error;phys.polarization.stokes.IdoublenullablestokesqPer-frequency Stokes polarization coefficients QmJy/beamphys.polarization.stokes.Qdoublenullablestokesq_errorError in stokesqmJy/beamstat.error;phys.polarization.stokes.QdoublenullablestokesuPer-frequency Stokes polarization coefficients UmJy/beamphys.polarization.stokes.Udoublenullablestokesu_errorError in stokesumJy/beamstat.error;phys.polarization.stokes.Udoublenullablegalactic_locationssa_location expressed in galactic coordinates (do not use for querying: there's no index on this).pos;pos.galacticdoublenullable
lotsspol.ssameta -The LOFAR Two Meter Sky Survey LoTSS DR2 -(:bibcode:`2022A&A...659A...1S`) obtained radio data from 27% of the -northern sky between 120 and 168 MHz in the year 2014 through 2020. This -service publishes polarization spectra of extragalactic radio sources -(radio galaxies and blazars) and the rotation measures derived from them. -We also give redshifts for all sources. The data has a spatial resolution -of 20 arcsec.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullable
lspmThe Lepine-Shara Catalog of High Proper Motion Stars The LSPM catalog is a comprehensive list of 61,977 stars north of the -J2000 celestial equator that have proper motions larger than 0.15"/yr -(local-background-stars frame). - -Positions are given with an accuracy of <~100 mas at the 2000.0 epoch, -and absolute proper motions are given with an accuracy of ~8 mas/yr. -The catalog is estimated to be over 99% complete at high Galactic -latitudes (|b|>15{deg}) and over 90% complete at low Galactic -latitudes (|b|>15{deg}), down to a magnitude.lspm.main The LSPM catalog is a comprehensive list of 61,977 stars north of the -J2000 celestial equator that have proper motions larger than 0.15"/yr -(local-background-stars frame). - -Positions are given with an accuracy of <~100 mas at the 2000.0 epoch, -and absolute proper motions are given with an accuracy of ~8 mas/yr. -The catalog is estimated to be over 99% complete at high Galactic -latitudes (|b|>15{deg}) and over 90% complete at low Galactic -latitudes (|b|>15{deg}), down to a magnitude.61977idLSPM star namemeta.id;meta.maincharnullableraj2000Right Ascension (J2000, Ep=J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000, Ep=J2000)degpos.eq.dec;meta.maindoubleindexednullablepmTotal Proper Motiondeg/yrpos.pmfloatnullablepmraProper Motion in Right Ascensiondeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper Motion in Declinationdeg/yrpos.pm;pos.eq.rafloatnullableaflagAstrometry sourcemeta.refcharnullablebmagOptical B magnitudemagphot.mag;em.opt.BfloatnullablevmagOptical V magnitudemagphot.mag;em.opt.VfloatnullablebjmagPhotographic Blue (IIIaJ) magnitudemagphot.mag;em.opt.BfloatnullablerfmagPhotographic Red (IIIaF) magnitudemagphot.mag;em.opt.RfloatnullableinmagPhotographic Infrared (IVN) magnitudemagphot.mag;em.opt.Rfloatnullablejmag2MASS J magnitudemagphot.mag;em.ir.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.ir.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.ir.Kfloatnullablevmag_eEstimated V magmagphot.mag;em.opt.Vfloatnullable
lswHDAP -- Heidelberg Digitized Astronomical PlatesScans of plates kept at Landessternwarte Heidelberg-Königstuhl. They -were obtained at location, at the German-Spanish Astronomical Center -(Calar Alto Observatory), Spain, and at La Silla, Chile. The plates -cover a time span between 1880 and 1999. - -Specifically, HDAP is essentially complete for the plates taken with -the Bruce telescope, the Walz reflector, and Wolf's Doppelastrograph -at both the original location in Heidelberg and its later home on -Königstuhl.lsw.plates The main catalog of the plates contained in the archive.19603accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableexposureEffective exposure timestime.duration;obs.exposurefloatnullableairmassAirmass at mean epochobs.airMassfloatnullableobjectSpecial object on platemeta.idcharnullableemulsionEmulsion of the original plateinstr.plate.emulsioncharnullablefilterFilter descriptionmeta.id;instr.filter;meta.maincharnullableobserverObserverobs.observercharnullablestarttimeUT at start of exposuredtime.start;obscharnullableendtimeUT at end of exposuredtime.end;obscharnullableplateidPlate name as specified in observation cataloguecharindexednullablepub_didDataset identifier assigned by the publisher.meta.ref.urlcharnullable
lsw.wolfpalisa A mapping between HDAP plate identifiers and Wolf-Palisa survey plate -numbers.210w_p_idPlate number in the Wolf-Palisa surveymeta.idcharnullableplateidPlate name as specified in observation cataloguecharnullable
magicMAGIC Public Spectra The MAGIC project observes the VHE sky (GeV~TeV) through Cherenkov -radiation events. The project is operating since 2004 and with the -support from the Spain-VO team they provide data access through a -VO-SSAP and web services. This service re-publishes the data with -homogeneized in flux units (given here in 'erg/(s.cm2)'). Photon -energy values in are transfomred to frequencies.magic.main The MAGIC project observes the VHE sky (GeV~TeV) through Cherenkov -radiation events. The project is operating since 2004 and with the -support from the Spain-VO team they provide data access through a -VO-SSAP and web services. This service re-publishes the data with -homogeneized in flux units (given here in 'erg/(s.cm2)'). Photon -energy values in are transfomred to frequencies.95accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_referencecharnullablereference_doicharnullableebl_correctedshortra_j2000Right Ascensiondegpos.eq.radoubledec_j2000Declinationdegpos.eq.decdouble
maidanakMaidanak Observatory Lens ImagesObservations of (mainly) lensed quasars from Maidanak Observatory, -Uzbekhistanmaidanak.reduced Reduced frames of lensed quasar observations from Maidanak -Observatory. See the referenceURL for details on the reduction -procedure and calibration data.accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoubleindexednullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefilenameFile name as supplied by the observatory -- unreliablemeta.idchartypeType of observation (science, flat, bias, calib...)meta.code.classcharobjectObject being observed, Simbad-resolvable formmeta.id;meta.maincharnullableraw_objectTarget object as supplied by the observatorymeta.idcharnullableobservatoryObservatory the image was obtained atmeta.id;instr.obstycharnullabletelescopeTelescope used to obtain the imageinstr.telcharnullableinstrumentIdentifier of the detecting instrumentinstr.setupcharnullabledetectorInternal detector IDmeta.id;instr.detcharnullableexposureExposure timestime.duration;obs.exposurefloatnullablestarttimeStart of exposure in UTtime.startcharnullableendtimeEnd of exposure in UTtime.endcharnullablechipidDetector Chipmeta.id;instr.detcharnullablep_dewarDewar Pressure (unreliable)phys.pressure;instr.paramfloatnullableari_rawRaw object name assigned at ARImeta.idcharnullablepub_didPublisher dataset Identifiermeta.ref.ivoidcharnullable
mcextinctReddening and Extinction maps of the Magellanic Clouds A catalogue of E(V-I) extinction values is presented for 3174 (LMC) -and 693 (SMC) fields within the Magellanic Clouds. The extinction -values were computed by determining the (V-I) colour difference of the -red clump from Optical Gravitational Microlensing Experiment (OGLE -III) observations in the V and I bands and theoretical values for -unreddend red clump colours.mcextinct.exts Extinction values within certain areas in the Magellanic clouds.3867bboxBounding box for the extinction datapos.outline;obs.fielddoublenullablecenteralphaArea center RA ICRSdegpos.eq.ra;meta.mainfloatindexednullablecenterdeltaArea center Declination ICRSdegpos.eq.dec;meta.mainfloatindexednullableev_iReddening (color difference between observation and theory, V-I)magphot.color.excess;em.opt.V;em.opt.Ifloatnullablesig_ev_iDifferential reddening calculated as FWHM of the red clump star distributionmagstat.stdev;phot.color.excessfloatnullable
mlqsoSpectra of Strongly Lensed Quasars -An archive of optical and near-infrared spectra of strongly lensed -quasars and the lensing galaxies. The spectra are resolved to about a -few Ångstroms and are flux-calibrated. The spectra resulted from -deblending the lensed images in bidimensional spectra available from -the SSAP service for `ivo://org.gavo.dc/mlqso/q/s -<http://dc.zah.uni-heidelberg.de/mlqso/q/s/info>`_.mlqso.cubes Bidirectional spectra as FITS image.12accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullabletarget_nameObject a targeted observation targetedmeta.id;srcobscore:Target.Namecharnullablet_exptimeTotal exposure timestime.duration;obs.exposureobscore:char.timeaxis.coverage.support.extentfloatnullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullabledatalinkDatalinks (related data, cutouts, etc) for this datasetmeta.ref.urlcharnullable
mlqso.slitspectra Bidimensional spectra of galaxies lensing QSOs.832accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.LengthintnullableremarkRemarks on the data set by the data creator.meta.notecharnullable
mpcMinor Planet Center - Asteroid Orbital Data -Complete Asteroid Data from the Minor Planet Center (MPC), -updated once per month. The MPC operates at the Smithsonian Astrophysical -Observatory under the auspices of Division III of the International -Astronomical Union (IAU). - -The MPC Orbit database contains orbital elements of minor -planets that have been published in the Minor Planet Circulars, -the Minor Planet Orbit Supplement and the Minor Planet -Electronic Circulars.mpc.epn_core EPN-TAP table for MPC Asteroid Orbital Data The EPN-TAP 2.0 version of the complete asteroid data from the Minor -Planet Center (MPC), updated once per month. The MPC operates at the -Smithsonian Astrophysical Observatory under the auspices of Division -III of the International Astronomical Union (IAU). - -The MPC Orbit database contains orbital elements of minor planets that -have been published in the Minor Planet Circulars, the Minor Planet -Orbit Supplement and the Minor Planet Electronic Circulars.ivo://ivoa.net/std/epntap#table-2.0granule_uidInternal table row index, which must be unique within the table. Can be alphanumeric.meta.idchargranule_gidCommon to granules of same type (e.g. same map projection, or geometry data products). Can be alphanumeric.meta.idcharobs_idAssociates granules derived from the same data (e.g. various representations/processing levels). Can be alphanumeric, may be the ID of original observation.meta.id;obschardataproduct_typeThe high-level organization of the data product, from a controlled vocabulary (e.g., 'im' for image, sp for spectrum). Multiple terms may be used, separated by # characters.meta.code.classcharnullabletarget_nameStandard IAU name of target (from a list related to target class), case sensitivemeta.id;srcunicodeCharnullabletarget_classType of target, from a controlled vocabulary.src.classcharnullabletime_minAcquisition start time (in JD), as UTC at time_refpositiondtime.start;obsdoublenullabletime_maxAcquisition stop time (in JD), as UTC at time_refpositiondtime.end;obsdoublenullabletime_sampling_step_minSampling time for measurements of dynamical phenomena, lower limit.stime.resolution;stat.mindoublenullabletime_sampling_step_maxSampling time for measurements of dynamical phenomena, upper limitstime.resolution;stat.maxdoublenullabletime_exp_minIntegration time of the measurement, lower limit.stime.duration;obs.exposure;stat.mindoublenullabletime_exp_maxIntegration time of the measurement, upper limitstime.duration;obs.exposure;stat.maxdoublenullablespectral_range_minSpectral range (frequency), lower limit.Hzem.freq;stat.mindoublenullablespectral_range_maxSpectral range (frequency), upper limitHzem.freq;stat.maxdoublenullablespectral_sampling_step_minSpectral sampling step, lower limit.Hzem.freq;spect.binSize;stat.mindoublenullablespectral_sampling_step_maxSpectral sampling step, upper limitHzem.freq;spect.binSize;stat.maxdoublenullablespectral_resolution_minSpectral resolution, lower limit.spect.resolution;stat.mindoublenullablespectral_resolution_maxSpectral resolution, upper limitspect.resolution;stat.maxdoublenullablec1minRight Ascension (ICRS), lower limit.degpos.eq.ra;stat.mindoublenullablec1maxRight Ascension (ICRS), upper limitdegpos.eq.ra;stat.maxdoublenullablec2minDeclination (ICRS), lower limit.degpos.eq.dec;stat.mindoublenullablec2maxDeclination (ICRS), upper limitdegpos.eq.dec;stat.maxdoublenullablec3minDistance from coordinate origin, lower limit.AUpos.distance;stat.mindoublenullablec3maxDistance from coordinate origin, upper limitAUpos.distance;stat.maxdoublenullables_regionObsCore-like footprint, valid for celestial, spherical, or body-fixed framespos.outline;obs.fieldcharnullablec1_resol_minResolution in the first coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec1_resol_maxResolution in the first coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec2_resol_minResolution in the second coordinate, lower limit.degpos.angResolution;stat.mindoublenullablec2_resol_maxResolution in the second coordinate, upper limitdegpos.angResolution;stat.maxdoublenullablec3_resol_minResolution in the third coordinate, lower limit.AUpos.resolution;stat.mindoublenullablec3_resol_maxResolution in the third coordinate, upper limitAUpos.resolution;stat.maxdoublenullablespatial_frame_typeFlavor of coordinate system, defines the nature of coordinates. From a controlled vocabulary, where 'none' means undefined.meta.code.class;pos.framecharnullableincidence_minIncidence angle (solar zenithal angle) during data acquisition, lower limit.degpos.incidenceAng;stat.mindoublenullableincidence_maxIncidence angle (solar zenithal angle) during data acquisition, upper limitdegpos.incidenceAng;stat.maxdoublenullableemergence_minEmergence angle during data acquisition, lower limit.degpos.emergenceAng;stat.mindoublenullableemergence_maxEmergence angle during data acquisition, upper limitdegpos.emergenceAng;stat.maxdoublenullablephase_minPhase angle during data acquisition, lower limit.degpos.phaseAng;stat.mindoublenullablephase_maxPhase angle during data acquisition, upper limitdegpos.phaseAng;stat.maxdoublenullableinstrument_host_nameStandard name of the observatory or spacecraftmeta.id;instr.obstycharnullableinstrument_nameStandard name of instrumentmeta.id;instrcharnullablemeasurement_typeUCD(s) defining the data, with multiple entries separated by hash (#) characters.meta.ucdcharnullableprocessing_levelDataset-related encoding, or simplified CODMAC calibration levelmeta.calibLevelintcreation_dateDate of first entry of this granuletime.creationcharnullablemodification_dateDate of last modification (used to handle mirroring)time.processingcharnullablerelease_dateStart of public access periodtime.releasecharnullableservice_titleTitle of resource (an acronym really, will be used to handle multiservice results)meta.titlecharnullablealt_target_nameProvides alternative target name if more common (e.g. comets); multiple identifiers can be separated by hashesmeta.id;srcunicodeCharnullablemagnitudeAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatnullableslope_parameterSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemi_major_axisOrbital semimajor axisAUphys.size.smajAxisfloatnullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mpc.mpcorb -Complete Asteroid Data from the Minor Planet Center (MPC), -updated once per month. The MPC operates at the Smithsonian Astrophysical -Observatory under the auspices of Division III of the International -Astronomical Union (IAU). - -The MPC Orbit database contains orbital elements of minor -planets that have been published in the Minor Planet Circulars, -the Minor Planet Orbit Supplement and the Minor Planet -Electronic Circulars.1200000designationAsteroid number or provisional designation.meta.id;meta.maincharnullablemagAbsolute Magnitude of the asteroid, i.e., the magnitude of the asteroid at a distance of 1 AU when viewed at a phase angle of 0°.magphys.magAbsfloatindexednullableslopeSlope Parameter G. It describes how the magnitude of the asteroid varies as a function of changing illumination (phase angle)src.morph.paramfloatnullableorb_epochEpoch of the orbit (julian years)atime.epochdoublenullablemean_anomalyMean anomaly at the epochdegsrc.orbital.meanAnomalyfloatnullablearg_perihelArgument of Perihelion, J2000.0degsrc.orbital.periastronfloatnullablelong_ascLongitude of ascending node, J2000.0degsrc.orbital.nodefloatnullableinclinationInclination of the orbit to the ecliptic, J2000.0degsrc.orbital.inclinationfloatnullableeccentricityEccentricity of the orbitsrc.orbital.eccentricityfloatnullablemean_motionMean Daily Motiondeg/dpos.pm;arith.diff;phys.velocfloatnullablesemimaj_axOrbital semimajor axisAUphys.size.smajAxisfloatindexednullableuncertaintyQuality code (0 is best) as per http://www.minorplanetcenter.org/iau/info/UValue.html. Or: E -- the orbital eccentricity was assumed; D -- for one-opposition orbits this means a double (or multiple) designation is involved; F -- an e-assumed double (or multiple) designation is involved.meta.code.errorcharnullablereferenceOrigin of the datameta.bibcharnullablen_obsNumber of Observationsmeta.number;obsintnullablen_oppNumber of Oppositionsmeta.numberintarc_lengthLength of observed arcs for single-opposition orbits.dtime.interval;time.epochshortnullablefirst_obsDiscovery year for multi-opposition orbits.atime.epochshortnullablerms_fitRMS Residual of orbital fitarcsecstat.fit.residualfloatnullableperturbersInformation on orbit perturbers; see table note.meta.notecharnullablecomputerIdentifies the computer of the orbitmeta.notecharnullableorbit_classOrbit family this object belongs to (note that the classification is based on cuts in osculating element space and is not 100% reliable.src.classcharnullablenameHuman-readable designation of the Asteroid.meta.idunicodeCharindexednullablelast_obsDate of last observationatime.epoch;obsfloatnullable
mwscGlobal Survey of Star Clusters in the Milky Way MWSC presents a list of 3006 Milky Way Stellar Clusters (MWSC), found -in the 2MAst (2MASS with Astrometry) catalogue. The target list was -compiled on the basis of present-day lists of open, globular and -candidate clusters. For confirmed clusters we determined a homogeneous -set of astrophysical parameters such as membership, angular radii of -the main morphological parts, mean cluster proper motions, distances, -reddenings, ages, tidal parameters, and sometimes radial velocities.mwsc.mainA list of milky way stellar cluster candidates and objects, together -with the notes and parameters from confirmed objects for the original -publication.3784recnoMWSC sequential number (cluster catalog number).meta.id;meta.maincharindexedprimarynameNGC, IC or other common designationmeta.idcharnullableconfirmation_flagIs this object a stellar cluster? 'dupe' indicates the object coincides with another cluster.charobject_typeObject typesrc.classcharnullableot_certainTrue if the object type is confirmed, false if object type has candidate status.meta.code;src.classbooleannullablesourceSource for MWSC list and input parametersmeta.refcharnullablesource_typeObject type from sourcesrc.classcharnullablen_starNumber of stars in MWSC sky area.meta.numberintraj2000Adopted cluster centre in RA J2000.0degpos.eq.ra;meta.maindoublenullabledej2000Adopted cluster centre in Dec J2000.0degpos.eq.dec;meta.maindoublenullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablercoreAngular radius of the coredegphys.angSize;srcfloatnullablercenterAngular radius of the central partdegphys.angSize;srcfloatnullablerclusterAngular radius of the clusterdegphys.angSize;srcfloatindexednullablepmraAverage proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.ra;stat.meanfloatnullablepmdeAverage proper motion in Declinationdeg/yrpos.pm;pos.eq.dec;stat.meanfloatnullablee_pmError of proper motiondeg/yrstat.error;pos.pm;pos.eq.ra;stat.meanfloatnullablervAverage radial velocitykm/sspect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablen_rvNumber of stars used for RVkm/smeta.number;spect.dopplerVeloc;pos.heliocentric;stat.meanintnullablen1s_coreNumber of most probable (1sigma) members within R(core)meta.numberintnullablen1s_centerNumber of most probable (1sigma) members within R(center); these are the stars used to compute the average proper motion.meta.numberintnullablen1s_clusterNumber of most probable (1sigma) members within R(cluster)meta.numberintnullabledistDistance from the Sunpcpos.distance;pos.heliocentricfloatindexednullablecol_ex_optColour excess in (B-V)magphot.color.excess;phot.color;em.opt.B;em.opt.Vfloatnullabledist_modApparent distance modulus in Ksmagphot.mag.distModfloatnullablecol_ex_jColour excess in (J-Ks)magphot.color.excess;phot.color;em.ir.J;em.ir.Kfloatnullablecol_ex_hColour excess in (J-H)magphot.color.excess;phot.color;em.ir.J;em.ir.Hfloatnullabledelta_hCorrection to H mag of fitted isochrone, empirically introduced to achieve a better fit in the Ks vs. J-H CMD. (see 2012A&A...543A.156K).magphot.mag;arith.difffloatnullablelogtLogarithm of average agelog(yr)time.age;stat.meanfloatindexednullablee_logtError in logarithm of average agelog(yr)stat.error;time.agefloatnullablentNumber of stars used for log(T) calculationmeta.numberintnullablercKing core radiuspcphys.size.radiusfloatnullablee_rcError of King core radiuspcstat.error;phys.size.radiusfloatnullablertKing tidal radiuspcphys.size.radiusfloatnullablee_rtError of King tidal radiuspcstat.error;phys.size.radiusfloatnullablekingkKing normalization factor (a measure of the central density of the cluster, see 2007A&A...468..151Ppc**-2stat.fit.paramfloatnullablee_kingkError of King normalization factorpc**-2stat.error;stat.fit.paramfloatnullablefe_hMetallicity [Fe/H]; this is copied from 2013arXiv1309.4325C or 2012A&A...539A.125D. Data for globular clusters is taken from the revised Harris (1996) catalogue, edition 2010, or newly determined.phys.abund.Fefloatindexednullablee_fe_hError of Metallicitystat.error;phys.abund.Fefloatnullablen_fe_hNumber of objects in [Fe/H] calculation.meta.numbershortnullablenote_textThe text of the note for an object.meta.notecharnullable
mwsc.starsData on cluster stars.64000000recnoMWSC number of the cluster containing the star.meta.id;meta.maincharindexedraj2000Stellar Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Stellar Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablemagbB magnitude in Johnson system.magphot.mag;em.opt.BfloatnullablemagvV magnitude in Johnson system.magphot.mag;em.opt.VfloatindexednullablemagjMagnitude in the 2MASS J bandmagphot.mag;em.ir.Jfloatindexednullablee_magjError in the magnitude in the 2MASS J bandmagstat.error;phot.mag;em.ir.JfloatnullablemaghMagnitude in the 2MASS H bandmagphot.mag;em.ir.Hfloatnullablee_maghError in the magnitude in the 2MASS H bandmagstat.error;phot.mag;em.ir.HfloatnullablemagksMagnitude in the 2MASS Ks bandmagphot.mag;em.ir.Kfloatnullablee_magksError in the magnitude in the 2MASS Ks bandmagstat.error;phot.mag;em.ir.KfloatnullablepmraStellar proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.rafloatnullablepmdeStellar proper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmError of stellar proper motiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablervStellar radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableqflg2MASS JHK photometric quality flagmeta.code.qual;photcharnullablerflg2MASS photometric read flagmeta.refcharnullablebflg2MASS photometric blend flagmeta.codecharnullabletwomassidUnique identifier in 2MASS (pts_key)meta.id.crossintasccIdentifier in ASCC 2.5meta.id.crossintnullablespectralSpectral type and luminosity classsrc.spTypecharnullabler_clAngular distance from cluster centredegpos.angDistancefloatnullablep_spatProbability of membership from spatial propertiesstat.probabilityfloatindexednullablep_kinProbability of membership from kinetic propertiesstat.probabilityfloatindexednullablep_jksProbability of membership from J, Ks photometrystat.probabilityfloatindexednullablep_jhProbability of membership from J, H photometrystat.probabilityfloatnullablemwsc.mainrecnorecno
mwsce14aGlobal Survey of Star Clusters in the Milky Way. III. 139 new open -clusters at high Galactic latitudes -MWSC-e14a ("MWSC extension 2014a") is a catalogue of -139 new open clusters at high Galactic latitudes -(\|b\|>20 deg) including lists of candidate members. It extends the -Kharchenko et al. 'Catalog of Milky Way Star Clusters'. -The target list was compiled as density enhancements found in the 2MASS -point source catalogue. For confirmed clusters we determined a homogeneous -set of astrophysical parameters such as membership, angular radii of the -main morphological parts, proper motion, distance, reddening, age, and -tidal parameters. - -.. _Catalog of Milky Way Star Clusters: http://dc.g-vo.org/mwsc/q/clu/formmwsce14a.main -MWSC-e14a ("MWSC extension 2014a") is a catalogue of -139 new open clusters at high Galactic latitudes -(\|b\|>20 deg) including lists of candidate members. It extends the -Kharchenko et al. 'Catalog of Milky Way Star Clusters'. -The target list was compiled as density enhancements found in the 2MASS -point source catalogue. For confirmed clusters we determined a homogeneous -set of astrophysical parameters such as membership, angular radii of the -main morphological parts, proper motion, distance, reddening, age, and -tidal parameters. - -.. _Catalog of Milky Way Star Clusters: http://dc.g-vo.org/mwsc/q/clu/form782recnoMWSC sequential number (cluster catalog number).meta.id;meta.maincharindexedprimarynameNGC, IC or other common designationmeta.idcharnullableconfirmation_flagIs this object a stellar cluster? 'dupe' indicates the object coincides with another cluster.charobject_typeObject typesrc.classcharnullableot_certainTrue if the object type is confirmed, false if object type has candidate status.meta.code;src.classbooleannullablesourceSource for MWSC list and input parametersmeta.refcharnullablesource_typeObject type from sourcesrc.classcharnullablen_starNumber of stars in MWSC sky area.meta.numberintraj2000Adopted cluster centre in RA J2000.0degpos.eq.ra;meta.maindoublenullabledej2000Adopted cluster centre in Dec J2000.0degpos.eq.dec;meta.maindoublenullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablercoreAngular radius of the coredegphys.angSize;srcfloatnullablercenterAngular radius of the central partdegphys.angSize;srcfloatnullablerclusterAngular radius of the clusterdegphys.angSize;srcfloatindexednullablepmraAverage proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.ra;stat.meanfloatnullablepmdeAverage proper motion in Declinationdeg/yrpos.pm;pos.eq.dec;stat.meanfloatnullablee_pmError of proper motiondeg/yrstat.error;pos.pm;pos.eq.ra;stat.meanfloatnullablervAverage radial velocitykm/sspect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentric;stat.meanfloatnullablen_rvNumber of stars used for RVkm/smeta.number;spect.dopplerVeloc;pos.heliocentric;stat.meanintnullablen1s_coreNumber of most probable (1sigma) members within R(core)meta.numberintnullablen1s_centerNumber of most probable (1sigma) members within R(center); these are the stars used to compute the average proper motion.meta.numberintnullablen1s_clusterNumber of most probable (1sigma) members within R(cluster)meta.numberintnullabledistDistance from the Sunpcpos.distance;pos.heliocentricfloatindexednullablecol_ex_optColour excess in (B-V)magphot.color.excess;phot.color;em.opt.B;em.opt.Vfloatnullabledist_modApparent distance modulus in Ksmagphot.mag.distModfloatnullablecol_ex_jColour excess in (J-Ks)magphot.color.excess;phot.color;em.ir.J;em.ir.Kfloatnullablecol_ex_hColour excess in (J-H)magphot.color.excess;phot.color;em.ir.J;em.ir.Hfloatnullabledelta_hCorrection to H mag of fitted isochrone, empirically introduced to achieve a better fit in the Ks vs. J-H CMD. (see 2012A&A...543A.156K).magphot.mag;arith.difffloatnullablelogtLogarithm of average agelog(yr)time.age;stat.meanfloatindexednullablee_logtError in logarithm of average agelog(yr)stat.error;time.agefloatnullablentNumber of stars used for log(T) calculationmeta.numberintnullablercKing core radiuspcphys.size.radiusfloatnullablee_rcError of King core radiuspcstat.error;phys.size.radiusfloatnullablertKing tidal radiuspcphys.size.radiusfloatnullablee_rtError of King tidal radiuspcstat.error;phys.size.radiusfloatnullablekingkKing normalization factor (a measure of the central density of the cluster, see 2007A&A...468..151Ppc**-2stat.fit.paramfloatnullablee_kingkError of King normalization factorpc**-2stat.error;stat.fit.paramfloatnullablefe_hMetallicity [Fe/H]; this is copied from 2013arXiv1309.4325C or 2012A&A...539A.125D. Data for globular clusters is taken from the revised Harris (1996) catalogue, edition 2010, or newly determined.phys.abund.Fefloatindexednullablee_fe_hError of Metallicitystat.error;phys.abund.Fefloatnullablen_fe_hNumber of objects in [Fe/H] calculation.meta.numbershortnullablenote_textThe text of the note for an object.meta.notecharnullable
mwsce14a.stars -MWSC-e14a ("MWSC extension 2014a") is a catalogue of -139 new open clusters at high Galactic latitudes -(\|b\|>20 deg) including lists of candidate members. It extends the -Kharchenko et al. 'Catalog of Milky Way Star Clusters'. -The target list was compiled as density enhancements found in the 2MASS -point source catalogue. For confirmed clusters we determined a homogeneous -set of astrophysical parameters such as membership, angular radii of the -main morphological parts, proper motion, distance, reddening, age, and -tidal parameters. - -.. _Catalog of Milky Way Star Clusters: http://dc.g-vo.org/mwsc/q/clu/form519163recnoMWSC number of the cluster containing the star.meta.id;meta.maincharindexedraj2000Stellar Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Stellar Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablemagbB magnitude in Johnson system.magphot.mag;em.opt.BfloatnullablemagvV magnitude in Johnson system.magphot.mag;em.opt.VfloatindexednullablemagjMagnitude in the 2MASS J bandmagphot.mag;em.ir.Jfloatindexednullablee_magjError in the magnitude in the 2MASS J bandmagstat.error;phot.mag;em.ir.JfloatnullablemaghMagnitude in the 2MASS H bandmagphot.mag;em.ir.Hfloatnullablee_maghError in the magnitude in the 2MASS H bandmagstat.error;phot.mag;em.ir.HfloatnullablemagksMagnitude in the 2MASS Ks bandmagphot.mag;em.ir.Kfloatnullablee_magksError in the magnitude in the 2MASS Ks bandmagstat.error;phot.mag;em.ir.KfloatnullablepmraStellar proper motion in RA*cos(DE)deg/yrpos.pm;pos.eq.rafloatnullablepmdeStellar proper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmError of stellar proper motiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablervStellar radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError of RVkm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableqflg2MASS JHK photometric quality flagmeta.code.qual;photcharnullablerflg2MASS photometric read flagmeta.refcharnullablebflg2MASS photometric blend flagmeta.codecharnullabletwomassidUnique identifier in 2MASS (pts_key)meta.id.crossintasccIdentifier in ASCC 2.5meta.id.crossintnullablespectralSpectral type and luminosity classsrc.spTypecharnullabler_clAngular distance from cluster centredegpos.angDistancefloatnullablep_spatProbability of membership from spatial propertiesstat.probabilityfloatindexednullablep_kinProbability of membership from kinetic propertiesstat.probabilityfloatindexednullablep_jksProbability of membership from J, Ks photometrystat.probabilityfloatindexednullablep_jhProbability of membership from J, H photometrystat.probabilityfloatnullablemwsce14a.mainrecnorecno
obscodeObservatory Codes List of Observatory Codes assigned by the Minor Planet Center (MPC). -The codes are used in cataloguing astrometric observations of small -bodies in the solar system. A code is unique for a certain location -and consists of three digits or one letter and two digits. - -In this representation, we give the observatory code, the geocentric -coordinates, and the observatory designation.obscode.data List of Observatory Codes assigned by the Minor Planet Center (MPC). -The codes are used in cataloguing astrometric observations of small -bodies in the solar system. A code is unique for a certain location -and consists of three digits or one letter and two digits. - -In this representation, we give the observatory code, the geocentric -coordinates, and the observatory designation.2280codeObservatory Code assigned by the Minor Planet Centermeta.idcharnullablelongLongitude of the observatorydegpos.earth.lonfloatnullablecosphipParallax constant, cosinefloatnullablesinphipParallax constant, sinefloatnullablegclatGeocentric latitude of the observatorydegpos.earth.lat;pos.geocentricfloatnullablegdlatGeodetic latitude of the observatory WGS84degpos.earth.lat;pos.geocentricfloatnullableheightAltitude of the observatorympos.earth.altitudefloatnullablenameOperator-chosen designation of the Observatorymeta.id;meta.maincharnullable
ohmaserA Database of Circumstellar OH MasersA all-sky compilation of galactic stellar sources observed for OH -maser emission in the transitions at 1612, 1665, and 1667 MHz. The -database contains OH maser observations selected from the literature . -These observations belong to more than 6000 different objects. The -database consists of three tables: The main table ("masers"), -interferometric followup observations ("maps") and monitoring programs -("monitor").ohmaser.bibrefsBibliographic and other metadata on the sources of the data in the -masers table.314ref_keyInternal key for the papercharindexedprimarybibcodeBibliographic reference to the data sourcemeta.bibcharnullablemodificationsModifications applied to data given in papercharnullablecommentsCompilators' CommentscharnullabletextrefHuman-readable reference to workcharnullabledet1612Sources detected at 1612 MHzintnullablendet1612Sources not detected at 1612 MHzintnullabledet1665Sources detected at 1665 MHzintnullablendet1665Sources not detected at 1665 MHzintnullabledet1667Sources detected at 1667 MHzintnullablendet1667Sources not detected at 1667 MHzintnullablecoosrcSource of coordinates given in databasecharnullableinputtablesTables evaluated from cited papercharnullable
ohmaser.mapsTable of interferometric measurements included.271measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableinstrumentName of the interferometer usedmeta.id;instrcharnullableresolutionSpatial resolution of the observationmasinstr.paramfloatnullablenon_det_flag< if observation is a non-detection.meta.codecharnullablermsRMS sensitivity of the observationJyinstr.sensitivityfloatnullablen_mapsNumber of maps obtained between obs_date_start and obs_date_endmeta.number;obsshortnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullableohmaser.maserssource_nosource_no
ohmaser.masersMaser data proper.13655measure_noUnique measurement identifiermeta.id;meta.mainintsource_noUnique, artificial source identifiermeta.codeintflagNon-null if this measurement is considered the best available at a particular frequency. Lower means higher confidence.meta.codeshortnullablesource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharfrequencyObserved frequencyMHzem.freqintnullablespec_typeS -- Single peak of maser emission; D -- Double peak of maser emission; I -- Irregular spectral profile, multiple emission peaks.meta.code;src.spTypecharnullablera_rawJ2000 RApos.eq.racharnullablede_rawJ2000 Decpos.eq.deccharnullableveloc_blueVelocity of the blue-shifted maser peak. For single-peak masers it contains the line velocity.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_redVelocity of the red-shifted maser peak in km/s. It contains the line velocity for a single peak maser if it corresponds to the red-shifted peak in other observations.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_centralRadial velocity of the central star. If veloc_central is not given in the reference, it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_shellOutflow Velocity of the shell. If vexp is not given in the reference it is calculated.km/sphys.veloc.expansion;pos.bodyrcfloatnullableveloc_errUncertainty of velocity values. Taken from the velocity resolution of the observation. It is actually a lower limit of the uncertainty, because the lines are usually much broader than velocity resolution of the observing equipment.km/sstat.error;phys.veloc.expansion;pos.bodyrcfloatnullableflux_dens_flagNULL -- flux density columns contain detections; < -- non-detection at level flux density blue (3 sigma); > -- flux density blue contains a lower limit for the flux; = -- source only gives fluxes; . -- flux density blue contains probable detection; : -- flux density red contains probable detection; & -- both flux densities contain probable detectionsmeta.codecharnullableflux_dens_blueFlux Density of the blue-shifted maser peak. For single-peak masers it contains its flux density.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableflux_dens_redFlux Density of the red-shifted maser peak. It contains the flux density for a single peak maser, if it corresponds to the red-shifted peak in other observations.Jyphot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_redIntegrated flux of red peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableint_flux_blueIntegrated flux of blue peak1e-22W.m**-2phot.flux.density;em.radio.1500-3000MHzfloatnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullablerapubRA of object, from sourcedegpos.eq.rafloatnullabledepubDec of object, from sourcedegpos.eq.decfloatnullableraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoubleindexednullablemapurlURL to information on an interferometric followup observation for this object.meta.ref.urlcharnullablemonitorurlURL to information on a monitor programme for this object.meta.ref.urlcharnullableohmaser.bibrefsref_keyref_key
ohmaser.monitorTable of measurements included from monitoring programs.180measure_noUnique measurement identifiermeta.id;meta.mainintsource_nameName of the observed source. The name given in the reference is usually kept.meta.idcharsource_noUnique, artificial source identifiermeta.codeintraj2000Selected best RA, J2000degpos.eq.ra;meta.maindoublenullabledej2000Selected best Dec, J2000degpos.eq.dec;meta.maindoublenullablefrequencyObserved frequencyMHzem.freqintnullableref_keyInternal key for the originating paper, see ohmasers.bibrefs.meta.bibcharnullableobs_date_startDate of the first observation, Julian years.yrtime.start;obsdoublenullableobs_date_endDate of last observation, Julian yearsyrtime.end;obsdoublenullablet_resApproximate time resolution of obs_date_*yrtime.resolutionfloatnullablemax_flux_dens_flag< if max_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemax_flux_dens_peakMaximal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.maxfloatnullablemin_flux_dens_flag< if min_flux_dens_peak is a 3σ upper limit.meta.codecharnullablemin_flux_dens_peakMinimal flux density observed (or 3σ upper limit)Jyphot.flux.density;em.radio;stat.minfloatnullableohmaser.maserssource_nosource_no
onebigb1BIGB: First Brazil-ICRANet Gamma-Ray Blazar Catalogue -This catalog presents the 1-100 GeV spectral energy distribution (SED) -for a population of 148 high-synchrotron-peaked blazars (HSPs) recently -detected with Fermi-LAT as part of the -First Brazil-ICRANet Gamma-ray Blazar catalogue (1BIGB). -A series of two works describe details on the broadband analysis: -:bibcode:`2017A&A...598A.134A`, and the calculation of the -gamma-ray SEDs :bibcode:`2018MNRAS.480.2165A`. - -The 1BIGB sample was originally selected from an excess signal in the -0.3-500 GeV band The flux estimates presented here are derived considering -PASS8 data, integrating over more than 9 years of Fermi-LAT observations. The -full broadband fit between 0.3-500 GeV presented in paper 1 for all sources -was reevaluated in paper 2, updating the power-law parameters with currentlyonebigb.measurementsA table of raw measurement points. See the seds table for combined -SEDs.1329idDatapoint IDmeta.id;meta.mainintiauidIAU-compliant identifier of the Blazarmeta.idcharnullableraRight Ascensiondegpos.eq.ra;meta.maindoublenullabledecDeclinationdegpos.eq.dec;meta.maindoublenullablefrequencyFlux measurement frequencyHzem.freqfloatnufnunuFnu Fluxerg.cm**-2.s**-1phot.fluxfloatnufnu_errornuFnu Flux errorerg.cm**-2.s**-1stat.error;phot.fluxfloatupper_limitFlux upper limitmeta.codecharnullable
onebigb.ssaSSA-compliant table of SEDs constructedaccrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatnullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatnullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperturedoubleindexednullablefrequencyFlux measurement frequencyHzem.freqfloatnufnunuFnu Fluxerg.cm**-2.s**-1phot.fluxfloatnufnu_errorError in nuFnu; a zero here indicates an upper limiterg.cm**-2.s**-1stat.error;phot.fluxfloat
openngcOpenNGC OpenNGC is a database containing positions and main data of NGC (New -General Catalogue) and IC (Index Catalogue) objects. It has been built -by merging data from NED, HyperLEDA, SIMBAD, and several databases -available at HEASARC. - -In this VO publication, we have changed most of the column names, -mostly to make them work as ADQL column names without resorting to -delimited identifiers. The mapping should be obvious.openngc.dataThe OpenNGC object list with the main metadata13969nameObject identifier, either from NGC or from IC.meta.id;meta.maincharindexednullableobj_typeObject Type. See note for terms and symbols used.src.classcharindexednullableraj2000Right Ascension in ICRS for Epoch J2000.0.degpos.eq.ra;meta.maindoublenullabledej2000Declination in ICRS for Epoch J2000.0.degpos.eq.dec;meta.maindoublenullableconstellationConstellation the object is located in.meta.id.parentcharnullablemaj_ax_degMajor axis of covering ellipsoid.degphys.angSize.sMajAxisfloatnullablemin_ax_degMinor axis of covering ellipsoid.degphys.angSize.sMinAxisfloatnullablepos_angPosition angle of covering ellipsoid, north over east.degpos.posAngfloatnullablemag_bApparent total magnitude in the B Band.magphot.mag;em.opt.Bfloatnullablemag_vApparent total magnitude in the V Band.magphot.mag;em.opt.Vfloatnullablemag_jApparent total magnitude in the J Band.magphot.mag;em.ir.Jfloatnullablemag_hApparent total magnitude in the H Band.magphot.mag;em.ir.Hfloatnullablemag_kApparent total magnitude in the K Band.magphot.mag;em.ir.Kfloatnullablesurf_br_bMean surface brigthness within the 25 mag isophote (B-band); only given for galaxiesmag/arcsec**2phot.mag.sbfloatnullablehubble_typeMorphological Hubble type for galaxies.src.morph.typecharindexednullablepmraProper motion in RAmas/yrpos.pm;pos.eq.rafloatnullablepmdecProper motion in Declinationmas/yrpos.pm;pos.eq.decfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVelocfloatnullablezHeliocentric redshiftsrc.redshiftfloatnullablecstar_mag_uFor planetary nebulae: Apparent magnitude of the central star in the U Band.magphot.mag;em.opt.Ufloatnullablecstar_mag_bFor planetary nebulae: Apparent magnitude of the central star in the B Band.magphot.mag;em.opt.Bfloatnullablecstar_mag_vFor planetary nebulae: Apparent magnitude of the central star in the V Band.magphot.mag;em.opt.Vfloatnullablemessier_nrMessier number for this objectmeta.id.crossintnullableother_ngcOther NGC number for this object in case it was duplicated in IC or NCG.meta.id.crosscharnullableic_crossOther IC number for this object in case it was duplicated in IC or NCG.meta.id.crosscharnullablecstar_idIdentifier of the central star for planetary nebulae.meta.id.crosscharnullableother_idCross reference to other catalogs.meta.id.crosscharnullablecomnameCommon name(s) of the object.charnullablened_notesNotes about the object exported from NEDmeta.notecharnullablesourcesSources of the various categories of datameta.bibcharnullablenotesNotes about the object from OpenNGCmeta.notecharnullable
openngc.shapes Hand-drawn coverages of selected openngc objects. Up to three -coverages at different surface brightness are obtained using the -default DSS2 Color layer in Aladin. Usually, the level 2 shape is -taken with default histogram, while level 1 and level 3 use, -respectvely, the first and the last half of the histogram.193nameName of the (main) object the coverage is for.meta.idcharindexedprimaryshape_level1Coverage obtained by tracing the object's outline visually in DSS colour, with full output intensity at half saturation.phys.angAreacharnullableshape_level2Coverage obtained by tracing the object's outline visually in DSS colour, with zero output intensity at zero saturation and full output intensity at full saturation.phys.angAreacharnullableshape_level3Coverage obtained by tracing the object's outline visually in DSS colour, with zero output intensity at half saturation and full output intensity at full saturation.phys.angAreacharnullabledeepest_shapeDeepest coverage available. As opposed to the other shape columns, this will always contain something as long as we have some coverage information; this is provided for convenience.phys.angArea;meta.maincharnullableopenngc.datanamename
pccA Catalog of Galaxies in the Direction of the Perseus Cluster This is a catalog of 5437 morphologically classified sources in the -direction of the Perseus galaxy cluster core, among them 496 -early-type low-mass galaxy candidates. The catalog is primarily based -on V-band imaging data acquired with the William Herschel Telescope. -Additionally, we used archival Subaru multiband imaging data in order -to measure aperture colors and to perform a morphological -classification. The catalog reaches its 50 per cent completeness limit -at an absolute V-band luminosity of -12 mag and a V-band surface -brightness of 26 mag arcsec^-2 . - -In addition to the published table, this service also contains cutout -images of the objects investigated.pcc.main This is a catalog of 5437 morphologically classified sources in the -direction of the Perseus galaxy cluster core, among them 496 -early-type low-mass galaxy candidates. The catalog is primarily based -on V-band imaging data acquired with the William Herschel Telescope. -Additionally, we used archival Subaru multiband imaging data in order -to measure aperture colors and to perform a morphological -classification. The catalog reaches its 50 per cent completeness limit -at an absolute V-band luminosity of -12 mag and a V-band surface -brightness of 26 mag arcsec^-2 . - -In addition to the published table, this service also contains cutout -images of the objects investigated.object_nameIdentifier from Wittman et al (2019).meta.id;meta.maincharindexedprimaryraICRS Right Ascension from WHT imagedegpos.eq.ra;meta.maindoubleindexednullabledecICRS Declination from WHT imagedegpos.eq.dec;meta.maindoubleindexednullablemagIntegrated V-band apparent magnitude corrected for extinction.magphot.mag;em.opt.Vdoublenullableerr_magError in integrated apparent magnitude for sources fitted with GALFIT (i.e., pflag = 1 .. 8; NULL otherwise)magstat.error;phot.mag;em.opt.Vfloatnullabler_50Half-light radius in the V band..arcsecphys.angsizefloatnullableerr_r_50Error in half-light radius in the V band.arcsecstat.error;phys.angsizefloatnullablemu50Effective V band surface brightness within R_50 corrected for extinctionmag.arcsec**-2phot.mag.sbfloatnullableerr_mu50Error in the effective surface brightness propagated from err_mag and err_r_50mag.arcsec**-2stat.error;phot.mag.sbfloatnullablesersic_indexSérsic index, upper limit constrained to 4 (cf. paper, sect. 4.3)stat.fit.paramfloatnullableerr_sersic_indexError in Sérsic index for sources fitted with GALFIT with free N parameter (pflag = 1)stat.error;stat.fit.paramfloatnullableb_aAxis ratio in the V band for sources fitted with GALFIT (pflag = 1 .. 8)phys.angsize;arith.ratiofloatnullableerr_b_aError in axis ratio for sources fitted with GALFIT with free B/A parameter (pflag = 1 - 4)stat.error;phys.angsize;arith.ratiofloatnullablepaPosition Angle for sources fitted with GALFIT and b_a < 0.9 [North/Up=0, East/Left=90]; from V band.degpos.posangfloatnullableerr_paError in position angle.degstat.error;pos.posangfloatnullablea_vV-band galactic foreground extinction.magphys.absorption;em.opt.VfloatnullablepflagPhotometry processing flag (see note).meta.codeshortresflag1 if there were significant residuals after substracting GALFIT model, 0 otherwise. This is only given for sources fitted with GALFIT (i.e., pflag = 1 .. 8)meta.code.qualshortnullablebgflagBackground fitted with: ...0: Galfit; ...1: SExtractor with BACK_SIZE = 256 pixel background map, ...2: like 1, but BACK_SIZE = 32 pixelmeta.codeshortg_r_1Subaru g-r for aperture 1, color corrected for extinction. (r_aper1 = 1 R50 for sources with R50 > 4 pixels, r_aper1 = 4 pixels for sources with R50 <= 4 pixels)magphot.color;em.opt.V;em.opt.Rfloatnullableerr_g_r_1Error in g-r for aperture 1magphot.color;em.opt.V;em.opt.Rfloatnullabler_z_1Subaru r-z for aperture 1, color corrected for extinction. (r_aper1 = 1 R50 for sources with R50 > 4 pixels, r_aper1 = 4 pixels for sources with R50 <= 4 pixels)magphot.color;em.opt.R;em.opt.Ifloatnullableerr_r_z_1Error in r-z for aperture 1magphot.color;em.opt.R;em.opt.Ifloatnullableg_r_2Subaru g-r for aperture 2, color corrected for extinction. (only for sources with R50 > 4 pixels, where r_aper2 = 2 R50)magphot.color;em.opt.V;em.opt.Rfloatnullableerr_g_r_2Error in g-r for aperture 2magphot.color;em.opt.V;em.opt.Rfloatnullabler_z_2Subaru r-z for aperture 2, color corrected for extinction. (only for sources with R50 > 4 pixels, where r_aper2 = 2 R50)magphot.color;em.opt.R;em.opt.Ifloatnullableerr_r_z_2Error in r-z for aperture 2magphot.color;em.opt.R;em.opt.Ifloatnullableg_r_flag1 if g-r photometry possibly comtaminated through bleeding trails of bright stars within 3 arcsec, 0 otherwisemeta.code.qualshortnullabler_z_flag1 if r-z photometry possibly comtaminated through bleeding trails of bright stars within 3 arcsec, 0 otherwisemeta.code.qualshortnullablea_gg-band galactic foreground extinction.magphys.absorption;em.opt.Vfloatnullablea_rr-band galactic foreground extinction.magphys.absorption;em.opt.Rfloatnullablea_zz-band galactic foreground extinction.magphys.absorption;em.opt.IfloatnullablemorphologyMorphological classificationsrc.classcharnullablenucleationRemark on nucleationsrc.classcharnullablecutout_linkLink to a FITS cutout for this source from an r-band mosaic. See datalink for additional retrieval options.meta.ref.urlcharnullable
plcCandidates for astrometric microlensingA catalogue of candidate stars for observing astrometric microlensing -using Gaia.plc.dataThe final candidate table with estimates of minimal distances, epochs, -etc.8932sourceSource of the data of the lensmeta.codecharnullablesrcidId of lensing objectmeta.id;meta.maincharnullablelensalphaJ2000 PPMX alpha of lensdegpos.eq.ra;meta.maindoubleindexednullablelensdeltaJ2000 PPMX delta of lensdegpos.eq.dec;meta.maindoubleindexednullablelensalphaerrError of lens alphadegstat.error;pos.eq.ra;meta.mainfloatnullablelensdeltaerrError of lens deltadegstat.error;pos.eq.dec;meta.mainfloatnullablelenspmalphaLens PM in alpha, cos(delta) applieddeg/yrfloatnullablelenspmdeltaLens PM in deltadeg/yrfloatnullablelenspmalphaerrError of Lens PM in alphadeg/yrfloatnullablelenspmdeltaerrError of Lens PM in deltadeg/yrfloatnullablelensmagPPMX catalogue magnitude of lensmagfloatnullablelensrmagPPMX Ru mag of lensmagfloatnullablelensbmagLens B mag as in PPMXmagfloatnullablelensvmagLens V mag as in PPMXmagfloatnullablelensjmagLens J mag as in PPMXmagfloatnullablelenshmagLens H mag as in PPMXmagfloatnullablelenskmagLens K mag as in PPMXmagfloatnullableobalphaJ2000 USNO alpha of lensed objectdegdoublenullableobdeltaJ2000 USNO delta of lensed objectdegdoublenullableobalphaerrPositional error of lensed object in alphadegfloatnullableobdeltaerrPositional error of lensed object in deltadegfloatnullableobpmalphaObject PM in alphadeg/yrfloatnullableobpmdeltaObject PM in deltadeg/yrfloatnullableobpmalphaerrError of Object PM in alphadeg/yrfloatnullableobpmdeltaerrError of Object PM in deltadeg/yrfloatnullableobbUSNO-B B mag magnitude of lensedfloatnullableobrUSNO-B R mag magnitude of lensedfloatnullableobiUSNO-B I mag magnitude of lensedfloatnullableobj2MASS J mag magnitude of lensedfloatnullableobh2MASS H mag magnitude of lensedfloatnullableobk2MASS K mag magnitude of lensedfloatnullablemindateEstimated time of closest approach (julian year)yrfloatnullablemindateerrError in estimation of time of closest approachyrfloatnullablemindistEstimated minimal distancedegfloatnullablemindisterrError in estimation of minimal distancedegfloatnullableconfirmed1 if lensing event confirmedboolean
plc2Astrometric Microlensing Events Predicted from Gaia DR2 From the Gaia DR2 catalogue we predict astrometric microlensing -events by foreground stars with high proper motion (µ_tot >150mas/yr) -passing a background source in the next decades. Using Gaia DR2 -photometry we determine an approximate mass of the lens, which we use -to calculate the expected microlensing effects. This yields 3914 -microlensing events by 2875 different lenses between 2010 and 2065 -with expected shifts larger than 0.1 mas between the lensed and -unlensed positions of the source. 513 of those are expected to happen -between 2014.5 - 2026.5 and might be measured by Gaia. For 127 events -we also expect a magnification between 1 mmag and 3 mag.plc2.dataThe final candidate table for astrometric microlensing events -predicted from Gaia DR2. This has estimates of minimal distances, -epochs, etc. Columns prefixed with lens_ are for the lens, columns -prefixed with ob_ are for the lensed object.3914event_idUnique identifier of this event. This is the decimal representation of the Gaia DR2 source_id of the lens, and a disambiguator for the lensed object.meta.id;meta.maincharindexedprimarylens_idGaia DR2 source_id of the lens.meta.idlonglens_raGaia DR2 RA of the lensdegpos.eq.ra;meta.maindoubleindexednullablelens_decGaia DR2 Declication of the lensdegpos.eq.dec;meta.maindoubleindexednullablelens_err_raError of lens__ra from Gaia DR2degstat.error;pos.eq.ra;meta.mainfloatnullablelens_err_decError of lens__dec from Gaia DR2degstat.error;pos.eq.dec;meta.mainfloatnullablelens_pmraProper motion in RA of the lens from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullablelens_pmdecProper motion in Declination of the lens from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullablelens_err_pmraError of lens_pmra from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullablelens_err_pmdecError of lens_pmdec from Gaia DR2deg/yrpos.pm;pos.eq.decfloatnullablelens_parallaxParallax of the lens from Gaia DR2degpos.parallaxfloatnullablelens_err_parallaxStandard error of the parallax the lens from Gaia DR2degstat.error;pos.parallaxfloatnullablelens_phot_g_mean_magMean magnitude of the lens in the integrated G band from Gaia DR2.magphot.mag;em.opt.Vfloatnullablelens_phot_rp_mean_magMean magnitude of the lens in the integrated RP band from Gaia DR2.magphot.mag;em.opt.Rfloatnullablelens_phot_bp_mean_magMean magnitude of the lens in the integrated BP band from Gaia DR2.magphot.mag;em.opt.Bfloatnullableob_idGaia DR2 source_id of the lensed object.meta.idlongob_raGaia DR2 RA of the lensed objectdegpos.eq.radoublenullableob_decGaia DR2 Declication of the lensed objectdegpos.eq.decdoublenullableob_err_raError of ob__ra from Gaia DR2degstat.error;pos.eq.rafloatnullableob_err_decError of ob__dec from Gaia DR2degstat.error;pos.eq.decfloatnullableob_pmraProper motion in RA of the lensed object from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullableob_pmdecProper motion in Declination of the lensed object from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullableob_err_pmraError of ob_pmra from Gaia DR2deg/yrpos.pm;pos.eq.rafloatnullableob_err_pmdecError of ob_pmdec from Gaia DR2deg/yrpos.pm;pos.eq.decfloatnullableob_parallaxParallax of the lensed object from Gaia DR2degpos.parallaxfloatnullableob_err_parallaxStandard error of the parallax the lensed object from Gaia DR2degstat.error;pos.parallaxfloatnullableob_phot_g_mean_magMean magnitude of the lensed object in the integrated G band from Gaia DR2.magphot.mag;em.opt.Vfloatnullableob_phot_rp_mean_magMean magnitude of the lensed object in the integrated RP band from Gaia DR2.magphot.mag;em.opt.Rfloatnullableob_phot_bp_mean_magMean magnitude of the lensed object in the integrated BP band from Gaia DR2.magphot.mag;em.opt.Bfloatnullablestar_typeType of the lensing star: WD = White Dwarf, MS = Main Sequence, RG = Red Giant, BD = Brown Dwarfsrc.classcharnullablemassEstimated mass of the lens from Gaia DR2solMassphys.massfloatnullableerr_massError in the mass of the lens from Gaia DR2solMassstat.error;phys.massfloatnullabletheta_eEinstein radius of the eventmasphys.angsizedoublenullableerr_theta_eError in the Einstein radius of the eventmasstat.error;phys.angsizefloatnullabletime_scaleApproximate duration of the eventyrtime.durationdoublenullabletcaEstimated time of the closest approach.yrtime.epochdoublenullableerr_tcaError in tca.yrstat.error;time.epochfloatnullabledistEstimated distance at closest approach.maspos.angdistancefloatnullableerr_distError d_min.masstat.error;pos.angdistancefloatnullableuEstimated distance at closest approach in Einstein radii.doublenullableerr_uError in u.floatnullableshiftMaximal astrometric shift of the center of light.maspos;arith.diffdoublenullableerr_shiftError in shiftmasstat.error;pos;arith.difffloatnullableshift_lumMaximal astrometric shift including lens-luminosity effects.maspos;arith.diffdoublenullableerr_shift_lumError in shift_lum.masstat.error;pos;arith.difffloatnullableshift_plusMaximal astrometric shift of brighter image.maspos;arith.diffdoublenullableerr_shift_plusError in shift_plus.masstat.error;pos;arith.difffloatnullablemagnificationMaximal magnification.magphot.mag;arith.ratiodoublenullableerr_magnificationError in magnification.magstat.error;phot.mag;arith.ratiofloatnullablel2_tcaEstimated time of the closest approachas seen from Earth-Sun L2 point.yrtime.epochdoublenullablel2_err_tcaError in l2_tca.yrstat.error;time.epochfloatnullablel2_distEstimated distance at closest approachas seen from Earth-Sun L2 point.maspos.angdistancefloatnullablel2_err_distError l2_d_min.masstat.error;pos.angdistancefloatnullablel2_uEstimated distance at closest approach in Einstein radiias seen from Earth-Sun L2 point.doublenullablel2_err_uError in l2_u.floatnullablel2_shiftMaximal astrometric shift of the center of lightas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_err_shiftError in l2_shiftmasstat.error;pos;arith.difffloatnullablel2_shift_lumMaximal astrometric shift including lens-luminosity effectsas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_err_shift_lumError in l2_shift_lum.masstat.error;pos;arith.difffloatnullablel2_shift_plusMaximal astrometric shift of brighter imageas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_err_shift_plusError in l2_shift_plus.masstat.error;pos;arith.difffloatnullablel2_magnificationMaximal magnificationas seen from Earth-Sun L2 point.magphot.mag;arith.ratiodoublenullablel2_err_magnificationError in l2_magnification.magstat.error;phot.mag;arith.ratiofloatnullable
plc3Astrometric Microlensing Events Predicted from Gaia eDR3 From the Gaia eDR3 catalogue we predict astrometric microlensing -events by foreground stars with high proper motion (μ > 100 mas/yr) -passing a background source in the next decades. Using Gaia DR3 -photometry we determine an approximate mass of the lens, which we use -to calculate the expected microlensing effects. This yields 4842 -microlensing events by 3791 different lenses between 2010 and 2066 -with expected shifts larger than 0.1 mas between the lensed and -unlensed positions of the source. The past events might be interested -when analyzing the individual Gaia measurements). 685 of those are -expected to happen within the next decade (2021-2031). For 140 events -we also expect a magnification between 1 mmag and 0.6 mag.plc3.dataThe final candidate table for astrometric microlensing events -predicted from Gaia eDR3. This has estimates of minimal distances, -epochs, etc. Columns prefixed with lens_ are for the lens, columns -prefixed with ob_ are for the lensed object.4842event_idUnique identifier of this event. This is the decimal representation of the Gaia eDR3 source_id of the lens, and a disambiguator for the lensed object.meta.id;meta.maincharindexedprimarylens_idGaia eDR3 source_id of the lens.meta.idlonglens_raGaia eDR3 RA of the lensdegpos.eq.ra;meta.maindoubleindexednullablelens_decGaia eDR3 Declination of the lensdegpos.eq.dec;meta.maindoubleindexednullablelens_err_raError of lens__ra from Gaia eDR3masstat.error;pos.eq.ra;meta.mainfloatnullablelens_err_decError of lens__dec from Gaia eDR3masstat.error;pos.eq.dec;meta.mainfloatnullablelens_pmraProper motion in RA of the lens from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullablelens_pmdecProper motion in Declination of the lens from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullablelens_err_pmraError of lens_pmra from Gaia eDR3deg/yrpos.pm;pos.eq.rafloatnullablelens_err_pmdecError of lens_pmdec from Gaia eDR3deg/yrpos.pm;pos.eq.decfloatnullablelens_parallaxParallax of the lens from Gaia eDR3maspos.parallaxfloatnullablelens_err_parallaxStandard error of the parallax the lens from Gaia eDR3masstat.error;pos.parallaxfloatnullablelens_phot_g_mean_magMean magnitude of the lens in the integrated G band from Gaia eDR3.magphot.mag;em.opt.Vfloatnullablelens_phot_rp_mean_magMean magnitude of the lens in the integrated RP band from Gaia eDR3.magphot.mag;em.opt.Rfloatnullablelens_phot_bp_mean_magMean magnitude of the lens in the integrated BP band from Gaia eDR3.magphot.mag;em.opt.Bfloatnullableob_idGaia eDR3 source_id of the lensed object.meta.idlongob_raGaia eDR3 RA of the lensed objectdegpos.eq.radoublenullableob_decGaia eDR3 Declination of the lensed objectdegpos.eq.decdoublenullableob_err_raError of ob__ra from Gaia eDR3masstat.error;pos.eq.rafloatnullableob_err_decError of ob__dec from Gaia eDR3masstat.error;pos.eq.decfloatnullableob_pmraProper motion in RA of the lensed object from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullableob_pmdecProper motion in Declination of the lensed object from Gaia eDR3mas/yrpos.pm;pos.eq.rafloatnullableob_err_pmraError of ob_pmra from Gaia eDR3deg/yrpos.pm;pos.eq.rafloatnullableob_err_pmdecError of ob_pmdec from Gaia eDR3deg/yrpos.pm;pos.eq.decfloatnullableob_parallaxParallax of the lensed object from Gaia eDR3maspos.parallaxfloatnullableob_err_parallaxStandard error of the parallax the lensed object from Gaia eDR3masstat.error;pos.parallaxfloatnullableob_phot_g_mean_magMean magnitude of the lensed object in the integrated G band from Gaia eDR3.magphot.mag;em.opt.Vfloatnullableob_phot_rp_mean_magMean magnitude of the lensed object in the integrated RP band from Gaia eDR3.magphot.mag;em.opt.Rfloatnullableob_phot_bp_mean_magMean magnitude of the lensed object in the integrated BP band from Gaia eDR3.magphot.mag;em.opt.Bfloatnullableob_displacement_ra_doubledDoubled Displacement in RA between DR2 and DR3, cos(δ) applied.maspos.eq.ra;arith.difffloatnullableob_displacement_dec_doubledDoubled Displacement in Dec between DR2 and DR3maspos.eq.dec;arith.difffloatnullablestar_typeType of the lensing star: WD = White Dwarf, MS = Main Sequence, RG = Red Giant, BD = Brown Dwarfsrc.classcharnullablemassEstimated mass of the lens from Gaia eDR3solMassphys.massfloatnullableerr_massError in the mass of the lens from Gaia eDR3solMassstat.error;phys.massfloatnullabletheta_eEinstein radius of the eventmasphys.angsizedoublenullableerr_theta_eError in the Einstein radius of the eventmasstat.error;phys.angsizefloatnullablet_amlApproximate duration of the event (i.e., shift > ~0.1 mas).yrtime.durationdoublenullabletcaEstimated time of the closest approach.yrtime.epochdoublenullableerr_tcaError in tca.yrstat.error;time.epochfloatnullabledistEstimated distance at closest approach.maspos.angdistancefloatnullableerr_distError d_min.masstat.error;pos.angdistancefloatnullableuEstimated distance at closest approach in Einstein radii.pos.angdistance;stat.mindoublenullableu_error_mLeft 67% confidence interval of u.stat.error;pos.angdistance;stat.minfloatnullableu_error_pRight 67% confidence interval of u.stat.error;pos.angdistance;stat.minfloatnullableshiftMaximal astrometric shift of the center of light.maspos;arith.diffdoublenullableshift_error_mLeft 67% confidence interval of shift.masstat.error;pos;arith.difffloatnullableshift_error_pRight 67% confidence interval of shift.masstat.error;pos;arith.difffloatnullableshift_lumMaximal astrometric shift including lens-luminosity effects.maspos;arith.diffdoublenullableshift_lum_error_mLeft 67% confidence interval of shift_lum.masstat.error;pos;arith.difffloatnullableshift_lum_error_pRight 67% confidence interval of shift_lum.masstat.error;pos;arith.difffloatnullableshift_plusMaximal astrometric shift of brighter image.maspos;arith.diffdoublenullableshift_plus_error_mLeft 67% confidence interval of shift_plus.masstat.error;pos;arith.difffloatnullableshift_plus_error_pRight 67% confidence interval of shift_plus.masstat.error;pos;arith.difffloatnullablemagnificationMaximal magnification.magphot.mag;arith.ratiodoublenullablemagnification_error_mLeft 67% confidence interval of magnification.magstat.error;phot.mag;arith.ratiofloatnullablemagnification_error_pRight 67% confidence interval of magnification.magstat.error;phot.mag;arith.ratiofloatnullablel2_tcaEstimated time of the closest approachas seen from Earth-Sun L2 point.yrtime.epochdoublenullablel2_err_tcaError in l2_tca.yrstat.error;time.epochfloatnullablel2_distEstimated distance at closest approachas seen from Earth-Sun L2 point.maspos.angdistancefloatnullablel2_err_distError l2_d_min.masstat.error;pos.angdistancefloatnullablel2_uEstimated distance at closest approach in Einstein radiias seen from Earth-Sun L2 point.pos.angdistance;stat.mindoublenullablel2_u_error_mLeft 67% confidence interval of l2_u.stat.error;pos.angdistance;stat.minfloatnullablel2_u_error_pRight 67% confidence interval of l2_u.stat.error;pos.angdistance;stat.minfloatnullablel2_shiftMaximal astrometric shift of the center of lightas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_shift_error_mLeft 67% confidence interval of l2_shift.masstat.error;pos;arith.difffloatnullablel2_shift_error_pRight 67% confidence interval of l2_shift.masstat.error;pos;arith.difffloatnullablel2_shift_lumMaximal astrometric shift including lens-luminosity effectsas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_shift_lum_error_mLeft 67% confidence interval of l2_shift_lum.masstat.error;pos;arith.difffloatnullablel2_shift_lum_error_pRight 67% confidence interval of l2_shift_lum.masstat.error;pos;arith.difffloatnullablel2_shift_plusMaximal astrometric shift of brighter imageas seen from Earth-Sun L2 point.maspos;arith.diffdoublenullablel2_shift_plus_error_mLeft 67% confidence interval of l2_shift_plus.masstat.error;pos;arith.difffloatnullablel2_shift_plus_error_pRight 67% confidence interval of l2_shift_plus.masstat.error;pos;arith.difffloatnullablel2_magnificationMaximal magnificationas seen from Earth-Sun L2 point.magphot.mag;arith.ratiodoublenullablel2_magnification_error_mLeft 67% confidence interval of l2_magnification.magstat.error;phot.mag;arith.ratiofloatnullablel2_magnification_error_pRight 67% confidence interval of l2_magnification.magstat.error;phot.mag;arith.ratiofloatnullablet_0_1_masApproximate duration on which shift_plus changes by 0.1 mas from its maximumyrtime.durationfloatnullablet_50pcApproximate duration on which shift_plus changes by 50% from its maximumyrtime.durationfloatnullable
pltsScans of the Palomar-Leiden Trojan Survey Plates -This service publishes plate scans of the Palomar-Leiden Troian -surveys conducted between 1960 and 1977. The surveys led to the -discovery of more than 2,000 asteroids (1,800 with orbital information), -with another 2,400 asteroids, including 19 Trojans, found after further -analysis of the plates. - -Note that because of the large size of the plates, in this service each -original plate is contained in two parts, marked with "_1" and "_2", -respectively. The central parts -of the two parts overlap.plts.data -This service publishes plate scans of the Palomar-Leiden Troian -surveys conducted between 1960 and 1977. The surveys led to the -discovery of more than 2,000 asteroids (1,800 with orbital information), -with another 2,400 asteroids, including 19 Trojans, found after further -analysis of the plates. - -Note that because of the large size of the plates, in this service each -original plate is contained in two parts, marked with "_1" and "_2", -respectively. The central parts -of the two parts overlap.699accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdVOX:Image_MJDateObsdoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableplatenumPlate IDmeta.idcharnullableplatepartScan index. Since the scanner used to digitise the plate was physically smaller than the plates, each plate scan consists of two parts. This number is either 1 or 2 correspondingly.meta.id.partshortwfpdb_idPlate identifier as in the WFPDBmeta.idcharnullableexposureEffective exposure timestime.duration;obs.exposurefloatnullableobsnotesObservation Notesmeta.notecharnullableemulsionEmulsion of the original plateinstr.plate.emulsioncharnullablepub_didPublisher data set id; this is an identifier for the dataset in question and can be used to retrieve the data through, e.g., datalink.meta.id;meta.maincharnullableobjectSpecial object on platemeta.idcharindexednullable
polcatsmcOptical Polarimetric Catalog for the SMC An optical polarimetric catalog for the Small Magelanic Cloud (SMC) -is presented. It gives intrinsic and observed polarizations in the -V-band for a total of 7207 stars located in the Northeast and Wing -sections of the SMC and part of the Magellanic Bridge.polcatsmc.data An optical polarimetric catalog for the Small Magelanic Cloud (SMC) -is presented. It gives intrinsic and observed polarizations in the -V-band for a total of 7207 stars located in the Northeast and Wing -sections of the SMC and part of the Magellanic Bridge.7207ctObject running numbermeta.id;meta.mainintraj2000Object Right Ascension ICRSdegpos.eq.ra;meta.maindoubleindexednullabledej2000Object Declination ICRSdegpos.eq.dec;meta.maindoubleindexednullablepol_obsObserved polarization in percent of total flux, obtained by determining the Q and U stokes parameters from V photometry in four different angles.floatnullablee_pol_obsError in observed polarization including pixel noise. The error is given in percent of the total flux.floatnullablepa_pol_obsPosition angle of the observed polarizationdegfloatnullablepol_intIntrinsic polarisation in per cent of total flux, obtained by substracting the foreground polarization due to Milky Way dust from the observed polarization pol_obs. See paper, chapter 3, for details on foreground determination.floatnullablee_pol_intError on the intrinsic polarisation, including errors on observed polarisation and the estimate of the polarization due to forground dust.floatnullablepa_pol_intPosition angle of the intrinsic polarisationdegfloatnullablevmagV band magnitude obtained by summing up the flux of the image pair in one frame and calibrating against several published catalogs (see Table 3 in the paper).magphot.mag;em.opt.Vfloatnullablee_vmagError in V band magnitude, including photon noise and dispersion in the magnitude calibration.magstat.error;phot.mag;em.opt.Vfloatnullable
ppakm31PPAKM31 – Optical Integral Field Spectroscopy of Star-Forming Regions -in M31 These observations cover five star-forming regions in the Andromeda -galaxy (M31) with optical integral field spectroscopy. Each has a -field of view of roughly 1 kpc across, at 10pc physical resolution. In -addition to the calibrated data cubes, we provide flux maps of the Hβ, -[OIII]5007, Hα, [NII]6583, [SII]6716 and [SII]6730 line emission. Line -fluxes have not been corrected for dust extinction. All data products -have associated error maps.ppakm31.cubes Spectral cubes of the fields. Look for these with full metadata in -the ivoa.obscore table, obs_collection 'ppakm31 cubes'.5accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.Sizelongnullableobs_idUnique identifier for an observationmeta.idobscore:DataID.observationIDcharnullableobs_publisher_didDataset identifier assigned by the publisher.meta.ref.ivoidobscore:curation.publisherdidcharnullableaccess_estsizeEstimated size of data productkbytephys.size;meta.fileobscore:access.sizelongnullableobs_titleFree-from title of the data setmeta.title;obsobscore:dataid.titlecharnullables_raRA of (center of) observation, ICRSdegpos.eq.raobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c1doublenullables_decDec of (center of) observation, ICRSdegpos.eq.decobscore:char.spatialaxis.coverage.location.coord.position2d.value2.c2doublenullablet_minLower bound of times represented in the data setdtime.start;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.starttimedoublenullablet_maxUpper bound of times represented in the data setdtime.end;obs.exposureobscore:char.timeaxis.coverage.bounds.limits.stoptimedoublenullables_regionRegion covered by the observation, as a polygonpos.outline;obs.fieldobscore:char.spatialaxis.coverage.support.areacharnullableem_minMinimal wavelength represented within the data setmem.wl;stat.minobscore:char.spectralaxis.coverage.bounds.limits.lolimitdoublenullableem_maxMaximal wavelength represented within the data setmem.wl;stat.maxobscore:char.spectralaxis.coverage.bounds.limits.hilimitdoublenullables_xel1Number of elements (typically pixels) along the first spatial axis.meta.numberobscore:Char.SpatialAxis.numBins1longnullables_xel2Number of elements (typically pixels) along the second spatial axis.meta.numberobscore:Char.SpatialAxis.numBins2longnullable
ppakm31.maps Extracted narrow-band images.30accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsRepresentative date of observation. In reality, data contributing to this observation has typically been obtained over about a month.dtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullablefieldInternal designation of the field being observed.charnullablecube_idIVOA publisher DID of the originating cube.meta.ref.ivoidcharnullablecube_linkDatalink URL for the cube this line was extracted from. This can be used to access the cube using datalink.charnullable
ppmxThe PPM-Extended (PPMX) catalogue of positions and proper motionsPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS -system containing astrometric and photometric information. Its -limiting magnitude is about 15.2 in the GSC photometric system.ppmx.dataPPM-Extended (PPMX) is a catalogue of 18 088 919 stars on the ICRS -system containing astrometric and photometric information. Its -limiting magnitude is about 15.2 in the GSC photometric system.19000000alphafloatMain value of right ascensiondegpos.eq.ra;meta.maindoubleindexednullabledeltafloatMain value of declinationdegpos.eq.dec;meta.maindoubleindexednullablec_xx coordinate of intersection of radius vector and unit spherepos.cartesian.xfloatnullablec_yy coordinate of intersection of radius vector and unit spherepos.cartesian.yfloatnullablec_zz coordinate of intersection of radius vector and unit spherepos.cartesian.zfloatnullablelocalidName (IAU convention HHMMSS.s+DDMMSS), p or f appended to desambiguatemeta.id;meta.maincharindexedprimarypmraProper Motion in RA*cos(delta)arcsec/yrpos.pm;pos.eq.rafloatnullablepmdeProper Motion in Decarcsec/yrpos.pm;pos.eq.decfloatnullableraerrMean error in RA*cos(DEmas) at epRAmasstat.error;pos.eq.rafloatnullabledecerrMean error in DE at epDEmasstat.error;pos.eq.decfloatnullablepmraerrMean error in pmRA*cos(DEmas)arcsec/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeerrMean error in pmDEarcsec/yrstat.error;pos.pm;pos.eq.rafloatnullableepraMean Epoch (RA)yrtime.epoch;pos.eq.racharnullableepdeMean Epoch (Dec)yrtime.epoch;pos.eq.deccharnullablecmagCatalogue magnitude from sourcemagphot.magfloatindexednullablermagcalculated Ru magnitude from sourcemagphot.mag;em.opt.RfloatnullablebmagB magnitude in Johnson systemmagphot.mag;em.opt.Bfloatnullablee_bmagStandard error on B magnitudemagstat.error;phot.mag;em.opt.BfloatnullablevmagV magnitude in Johnson systemmagphot.mag;em.opt.Vfloatindexednullablee_vmagStandard error on V magnitudemagstat.error;phot.mag;em.opt.VfloatnullablejmagJ magnitude in Johnson systemmagphot.mag;em.IR.Jfloatnullablee_jmagStandard error on J magnitudemagstat.error;phot.mag;em.IR.JfloatnullablehmagH magnitude in Johnson systemmagphot.mag;em.IR.Hfloatnullablee_hmagStandard error on H magnitudemagstat.error;phot.mag;em.IR.HfloatnullablekmagK magnitude in Johnson systemmagphot.mag;em.IR.Kfloatnullablee_kmagStandard error on K magnitudemagstat.error;phot.mag;em.IR.Kfloatnullablen_obsnumber of observations in LSQ fitmeta.number;obsintnullablep_flagTrue if LSQ fit is badmeta.code.qualbooleansub_flagSubset flagmeta.codecharnullablesrccatSource cataloguemeta.refcharnullablesrcidStar identifier in the source cataloguemeta.id.crosscharnullablepm_totalTotal proper motionarcsec/yrpos.pmfloatindexednullableangle_pmPosition angle of total proper motiondegpos.posAng;pos.pmfloatnullable
ppmxlThe PPMXL Catalog -PPMXL is a catalog of positions, proper motions, 2MASS- and optical -photometry of 900 million stars and galaxies, aiming to be complete -down to about V=20 full-sky. It is the result -of a re-reduction of USNO-B1 together with 2MASS to the ICRS as -represented by PPMX. This service additionally provides improved proper -motions computed according to Vickers et al, 2016 -(:bibcode:`2016AJ....151...99V`).ppmxl.main -PPMXL is a catalog of positions, proper motions, 2MASS- and optical -photometry of 900 million stars and galaxies, aiming to be complete -down to about V=20 full-sky. It is the result -of a re-reduction of USNO-B1 together with 2MASS to the ICRS as -represented by PPMX. This service additionally provides improved proper -motions computed according to Vickers et al, 2016 -(:bibcode:`2016AJ....151...99V`).900000000ipixIdentifier (Q3C ipix of the USNO-B 1.0 object)meta.id;meta.mainlongindexedraj2000Right Ascension J2000.0, epoch 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000.0, epoch 2000.0degpos.eq.dec;meta.maindoubleindexednullablee_raepraMean error in RA*cos(delta) at mean epochdegstat.error;pos.eq.ra;meta.mainfloatnullablee_deepdeMean error in Dec at mean epochdegstat.error;pos.eq.dec;meta.mainfloatnullablepmraProper Motion in RA*cos(delta)deg/yrpos.pm;pos.eq.rafloatindexednullablepmdeProper Motion in Decdeg/yrpos.pm;pos.eq.decfloatindexednullablee_pmraMean error in pmRA*cos(delta)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error in pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablenobsNumber of observations usedmeta.number;obsshortnullableepraMean Epoch (RA)yrtime.epoch;pos.eq.rafloatnullableepdeMean Epoch (Dec)yrtime.epoch;pos.eq.decfloatnullablejmagJ selected default magnitude from 2MASSmagphot.mag;em.IR.Jfloatnullablee_jmagJ total magnitude uncertaintymagstat.error;phot.mag;em.IR.JfloatnullablehmagH selected default magnitude from 2MASSmagphot.mag;em.IR.Hfloatnullablee_hmagH total magnitude uncertaintymagstat.error;phot.mag;em.IR.HfloatnullablekmagK_s selected default magnitude from 2MASSmagphot.mag;em.IR.Kfloatnullablee_kmagK_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullableb1magB mag from USNO-B, first epochmagphot.mag;em.opt.Bfloatnullableb2magB mag from USNO-B, second epochmagphot.mag;em.opt.Bfloatnullabler1magR mag from USNO-B, first epochmagphot.mag;em.opt.Rfloatnullabler2magR mag from USNO-B, second epochmagphot.mag;em.opt.RfloatnullableimagI mag from USNO-Bmagphot.mag;em.opt.IfloatnullablemagsurveysSurveys the USNO-B magnitudes are taken frommeta.codecharnullableflagsFlagsmeta.codeshortvickers_pmraProper motion in RA as re-corrected according to 2016AJ....151...99V, cos(delta) applied. This is only available for objects with 2MASS J magnitudes. e_pmRA still is suitable as an error estimate.deg/yrpos.pm;pos.eq.rafloatnullablevickers_pmdeProper motion in Dec as re-corrected according to 2016AJ....151...99V. This is only available for objects with 2MASS J magnitudes. e_pmDE still is suitable as an error estimate.deg/yrpos.pm;pos.eq.decfloatnullable
ppmxl.usnocorrCorrections between USNO-B1 and PPMXL on a grid of degrees, obtained -by substracting PPMXL from USNO in cones of radius sqrt(2)/2 degrees -around the given center position.64800nobNumber of objects the correction is based onmeta.numberintalphaCenter for field, RAdegpos.eq.ra;meta.mainfloatindexednullabledeltaCenter for field, Decdegpos.eq.dec;meta.mainfloatindexednullabled_alphaCorrection PPMXL-USNO in alpha (Epoch 2000.0)degpos.eq.ra;arith.difffloatnullabled_deltaCorrection PPMXL-USNO in delta (Epoch 2000.0)degpos.eq.dec;arith.difffloatnullabled_pmalphaCorrection PPMXL-USNO in proper motion alpha*cos(delta)deg/yrpos.pm;pos.eq.ra;arith.difffloatnullabled_pmdeltaCorrection PPMXL-USNO in deltadeg/yrpos.pm;pos.eq.dec;arith.difffloatnullable
prdustBayestar17 3D Dust Mapping with Pan-STARRS 1 -A 3D map of interstellar dust reddening, covering three -quarters of the sky (declinations greater than -30 degrees) out to a -distance of several kiloparsecs. The map is based on high-quality stellar -photometry of 800 million stars from Pan-STARRS 1 and 2MASS. - -The map is available for five HEALPix levels (6 through 10), published -here as separate tables, map6 through map10. A union of the coverage is -provided as map_union. Use its coverage column to match against other -tables. - -See http://argonaut.rc.fas.harvard.edu/ for more details.prdust.map10 The HEALPix map for order 10 (nside=1024); the pixel scale is about -3.4'. - -In ADQL, all array indices are 1-based.2200000healpixThe healpix (of order 10) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map6 The HEALPix map for order 6 (nside=64); the pixel scale is about 55'. - -In ADQL, all array indices are 1-based.74healpixThe healpix (of order 6) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map7 The HEALPix map for order 7 (nside=128); the pixel scale is about -27'. - -In ADQL, all array indices are 1-based.410healpixThe healpix (of order 7) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map8 The HEALPix map for order 8 (nside=256); the pixel scale is about -14'. - -In ADQL, all array indices are 1-based.192156healpixThe healpix (of order 8) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map9 The HEALPix map for order 9 (nside=512); the pixel scale is about -6.9'. - -In ADQL, all array indices are 1-based.1100000healpixThe healpix (of order 9) of which the extinction data is given. This is in Galactic l, b.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullable
prdust.map_unionJoined Bayestar17 3D Dust MapThis is a view of the dust maps in the five orders, generated by -splitting the larger pixels from the higher orders into HEALPixes of -order 10. This means, in particular, that the spatial resolution for -all pixels with original_order!=10. Use this for convenient joins to -other tables.healpixThe healpix (in galactic l, b) for which this data applies. This is of the order given in the hpx_order column, and thus it's not usually useful for querying. Query against the coverage column instead.pos.healpixintindexedprimarycoverageArea (as order-10-healpix interval) covered by this healpix.phys.angAreaintindexednullableconverged1 if the line-of-sight reddening fit converged, 0 otherwise.meta.codeshortdm_reliable_minMinimum reliable distance modulus.magfloatnullabledm_reliable_maxMaximum reliable distance modulus.magfloatnullablen_starsNumber of stars used to fit the line-of-sight reddening.meta.numberintnullablen_goodThe number of stars in the sightline with good convergence, and which passed a cut on Bayesian evidence (termed "good" stars).meta.numberintnullablen_dwarfsThe number of "good" stars which are inferred to be Main-Sequence stars.meta.numberintnullablegrdiagnosticGelman-Rubin convergence diagnostic in each HEALpix; a HEALpix can be considered good if diagnostic is below 1.2.floatnullablebest_fitThe best-fit (maximum proability density) line-of-sight reddening, in units of SFD-equivalent E(B-V), in each distance bin; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags.magphys.absorptionfloatnullablesamples18 samples of E(B-V) in each distance bin drawn from the MCMC chain; the bins are 4 .. 19 mag of distance modulus, spaced 0.5 mags. This information can be used to estimate the reliability of best_fit (e.g., a standard deviation).magphys.absorption;src.samplefloatnullablehpx_orderThe HEALPix order healpix is given for. The dust map is not regularly sampled, which is why orders vary over the sky. For querying, it is simpler to look at coverage than at healpix+order.meta.number;pos.healpixshort
raveRAdial Velocity Experiment: RAVE DR5 The RAdial Velocity Experiment (RAVE) contains stellar atmospheric -parameters (effective temperature, surface gravity, overall -metallicity), radial velocities, chemical abundances and distances. -Observations between 2003 and 2013 were used to build the five RAVE -data releases.rave.dr2Data Release 2 -The second data release of RAVE contains spectroscopic radial velocities -for 49327 stars in the Milky-Way southern hemisphere using the 6dF -instrument at the AAO. Stellar parameters are published for a set of 21121 -stars belonging to the second year of observation. - -This data collection has been superceded by RAVE data release 3 -(`table rave.dr </__system__/dc_tables/show/tableinfo/rave.dr3>`_ -in the data center). - -The data published here comprises all original RAVE data. Columns -in the data release that resulted from crossmatching were left out. - -For details, see 2008MNRAS.391..793S.51829nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvHRV errorkm/sstat.errorfloatnullablepmraProper motion in RAmas/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAmas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationmas/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationmas/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (0 - no PM; 1 - Tycho-2; 2 - Supercosmos; 3 - STARNET 2.0; 4 - GSC1.2x2MASS; 5 - UCAC-2)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationdtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;instr.paramshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablem_h_uncalUncalibrated [M/H]phys.abund.Fefloatnullablealfa_fealpha enhancement [{alpha}/Fe]phys.abundfloatnullablem_hCalibrated [M/H], Sun=1phys.abund.Fefloatnullablechi2chi squarestat.fit.chi2doublenullablesnrCorrected signal to noisestat.snrfloatnullabletdccTonry-Davis correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectra signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag [dispersion around correction <1 (A), 1..2 (B), 2..3 (C), >3 km/s (D); E - less than 15 fibers available.]meta.codecharnullablezp250 fibers group to which the fiber belongs zero point correction flagmeta.codecharnullablegapwarningFiber is close to a 15 fibers gapmeta.codebooleanqualSpectra quality flag [a - asymmetric Ca lines; c - cosmic ray pollution; e - emission line spectra; n - noise dominated spectra; l - no lines visible; w - weak lines; g - strong ghost; t - bad template fit; s - strong residual sky emission; cc - bad continuum; r - red part of the spectra shows problem; b - blue part of the spectra shows problem; p - possible binary/doubled lined; x - peculiar object;]meta.code.qualcharnullable
rave.dr3 -The third data release of RAVE contains spectroscopic radial velocities -for 83072 stars in the Milky-Way southern hemisphere using the 6dF -instrument at the AAO. - -This data collection has been superceded by RAVE data release 4 -(`table rave.dr </__system__/dc_tables/show/tableinfo/rave.main>`_ -in the data center). - -Columns in the data release that resulted from crossmatching were -left out. - -For details, see 2011AJ....141..187S.83072nameTarget designationmeta.id;meta.maincharnullablealtnameTarget alternative designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatnullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablee_pmraError in proper motion in RAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepmsrcSource of proper motion (see note)meta.ref;pos.pm;pos.eq.decshortnullableimagInput catalog I magnitudemagphot.mag;em.opt.IfloatnullableobsdateDate of observationyrtime.epoch;obscharnullablefieldName of RAVE fieldmeta.id;obs.fieldcharnullableplatePlate number usedmeta.id;obs.fieldshortfiberFiber numbermeta.idshortteffEffective TemperatureKphys.temperature.effectiveintnullableloggGravityphys.gravityfloatnullablemetMetallicity [m/H]phys.abund.Fefloatnullablealphaalpha enhancement [{alpha}/Fe]phys.abundfloatnullablechi2Chi square of continuum fitstat.fit.chi2doublenullablesnr2DR2 signal to noise ratiostat.snrfloatnullablesnrPre-flux calibration signal to noisestat.snrfloatnullabletdccTonry-Davis R correlation coefficientstat.fit.paramfloatnullablehcpHeight of correlation peakstat.correlationfloatnullablewcpWidth of correlation peakkm/sstat.correlationfloatnullablezeropointZero point correction appliedkm/sarith.zpfloatnullablehrvskyMeasured heliocentric radial velocity of skykm/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_hrvskyError HRV of skykm/sstat.errorfloatnullabletdccskySky Tonry-Davis correlation coefficientstat.fit.paramfloatnullablesnrspecSpectrum signal to noise ratiostat.snrfloatnullablezp1Entire plate zero point correction flag (see note)meta.codecharnullablequalSpectrum quality flag (see note)meta.code.qualcharnullablemaskflagFraction of spectrum unaffected by continuum problems (see note)meta.code.qualfloatnullable
rave.dr4The RAVE object catalog, data release 4. - -Note that columns with names ending in _k originate from the stellar -parameters pipeline, those with names ending in _c come from the -chemical pipeline, those with name ending in _sparv come from the -radial velocity pipeline. Names ending in _n_k indicate calibrated -values.482194nameTarget designationmeta.id;meta.maincharindexedprimaryaltnameRAVE target designationmeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablecorrelation_coeffTonry & Davis R correlation coefficientstat.fit.paramfloatnullablepeak_heightHeight of the correlation peak.stat.correlationfloatnullablepeak_widthWidth of the correlation peak.stat.correlationfloatnullableskyhrvMeasured heliocentry radial velocity of the sky.km/sspect.dopplerVeloc;obs.field;pos.heliocentricfloatnullablee_skyhrvError in the measured heliocentric velocity of the sky.km/sstat.error;spect.dopplerVeloc;obs.field;pos.heliocentricfloatnullabletdccskyTonry & Davis R Sky correlation coefficient.stat.fit.paramfloatnullablecorrection_rvZero point correction applied to the radial velocity solutions (see 2011AJ....141..187S).km/sarith.zpfloatnullablezeropoint_flagQuality flag for Zero point correctionmeta.codecharnullableteff_sparvEffective temperature as determined by the radial velocity pipeline.Kphys.temperature.effectivefloatnullablelogg_sparvLog gravity as determined by the radial velocity pipeline.phys.gravityfloatnullablealpha_sparvMetallicity as determined by the radial velocity pipeline.phys.abund.ZfloatnullableageLogarithm of age (from 2014MNRAS.437..351B)log(a)time.agefloatnullablee_ageError in Age (from 2014MNRAS.437..351B)log(a)stat.error;time.agefloatnullablemassMass (from 2014MNRAS.437..351B)solMassphys.massfloatnullablee_massError Mass (from 2014MNRAS.437..351B)solMassstat.error;phys.massfloatnullable
rave.mainThe RAVE object catalog of radial velocities, surface gravities, and -chemical parameters for about 500000 stars, data release 5. We have -removed almost all fields originating from crossmatches (as this is -intended for use within our TAP service, where users can do the -crossmatches themselves). Also, some obviously buggy columns (e.g., -footprint_flag) were dropped. - -Note that columns with names ending in _k originate from the stellar -parameters pipeline, those with names ending in _c come from the -chemical pipeline. Columns ending in _n_k indicate calibrated values.520629rave_obs_idUnique Identifier for RAVE objects: Observation Date, Fieldname, Fibernumbermeta.id;meta.maincharindexedprimaryraveidMain RAVE identifiermeta.idcharnullableraj2000Right ascension (J2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000.0)degpos.eq.dec;meta.maindoubleindexednullableglonGalactic longitudedegpos.galactic.londoublenullableglatGalactic latitudedegpos.galactic.latdoublenullablervHeliocentric radial velocitykm/sspect.dopplerVeloc;pos.heliocentricfloatindexednullablee_rvError in heliocentric radial velocitykm/sstat.error;spect.dopplerVeloc;pos.heliocentricfloatnullableobsdateObservation date.dtime.epoch;obsdoublenullablefield_nameName of RAVE field (RA/DE)meta.id;obs.fieldcharnullableplate_numberNumber of field plate [1..3]meta.id;obs.fieldshortfiber_numberNumber of optical fiber used to obtain the spectrum [1,150].meta.number;instr.setupshortteff_kEffective temperature from the stellar parameter pipeline.Kphys.temperature.effectivefloatnullablee_teff_kError in the effective temperature from the stellar parameter pipeline.Kstat.error;phys.temperature.effectivefloatnullablelogg_kLog gravity as determined by the stellar pipeline.phys.gravityfloatnullablee_logg_kError in logg_k.stat.error;phys.gravityfloatnullablemet_kMetallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablemet_n_kCalibrated metallicity [m/H] from the stellar parameter pipeline.phys.abund.Zfloatnullablee_met_kError in metallicity [m/H] from the stellar parameter pipeline.stat.error;phys.abund.Zfloatnullablesnr_kSignal to noise value for the stellar parameter pipeline.stat.snrfloatindexednullablealgo_conv_kQuality flag for stellar parameter pipeline [0..4].meta.code.qualfloatnullablealAbundance of Al [Al/H]phys.abundfloatnullableal_nNumber of spectral lines used for the computation of Al abundance.phys.abundintnullablesiAbundance of Si [Si/H]phys.abundfloatnullablesi_nNumber of spectral lines used for the computation of Si abundance.phys.abundintnullablefeAbundance of Fe [Fe/H]phys.abund.Fefloatnullablefe_nNumber of spectral lines used for the computation of Fe abundance.phys.abundintnullabletiNumber of spectral lines used for the computation of Ti abundance.phys.abundfloatnullableti_nNumber of used spectral lines for calculation of Ti abundance.phys.abundintnullableniAbundance of Ni [Ni/H]phys.abundfloatnullableni_nNumber of spectral lines used for the computation of Ni abundance.phys.abundintnullablemgAbundance of Mg [Mg/H]phys.abundfloatnullablemg_nNumber of spectral lines used for the computation of Mg abundance.phys.abundintnullablejmag2MASS J magnitudemagphot.mag;em.IR.Jfloatindexednullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablechisq_cχ² of the Chemical Pipelinestat.fit.chi2floatnullableid_2mass2MASS Target designationmeta.idcharnullableid_denisDENIS Target designationmeta.idcharnullableid_usnob1USNOB1 Target designationmeta.idcharnullableid_tycho2TYCHO2 target designationmeta.idcharnullableid_ucac4UCAC4 target designationmeta.idcharnullableid_ppmxlPPMXL target designation.meta.idlongnullableparallaxParallax (from 2014MNRAS.437..351B)maspos.parallaxfloatnullablee_parallaxError Parallax (from 2014MNRAS.437..351B)masstat.error;pos.parallaxfloatnullabledist_binneyDistance (from 2014MNRAS.437..351B)kpcpos.distancefloatnullablee_distError in Distance (from 2014MNRAS.437..351B)kpcstat.error;pos.distancefloatnullabledistance_modulusDistance modulus (from 2014MNRAS.437..351B)phot.mag.distModfloatnullablee_distance_modulusDistance modulus (from 2014MNRAS.437..351B)stat.error;phot.mag.distModfloatnullablelog_avExtinction (from 2014MNRAS.437..351B)phys.absorptionfloatnullablee_log_avError in extinction (from 2014MNRAS.437..351B)stat.error;phys.absorptionfloatnullablemin_dists20 minimum distances to the base spectrum given by alphabetic codes from 2012ApJS..200...14M.charnullablestddev_rvStandard deviation in HRV from 10 resampled spectrakm/sstat.stdev;spect.dopplerVeloc;pos.heliocentricfloatnullablemad_rvMedian absolute deviation in HRV from 10 resampled spectrakm/sstat.fit.residual;spect.dopplerVeloc;pos.heliocentric;stat.medianfloatnullablestddev_teff_kStandard deviation in Teff_K from 10 resampled spectraKstat.stdev;phys.temperature.effectivefloatnullablemad_teff_kMedian absolute deviation in Teff_K from 10 resampled spectraKstat.fit.residual;phys.temperature.effective;stat.medianfloatnullablestddev_logg_kStandard deviation in Teff_K from 10 resampled spectrastat.stdev;phys.gravityfloatnullablemad_logg_kMedian absolute deviation in metallicity from 10 resampled spectrastat.fit.residual;phys.abund.Z;stat.medianfloatnullablestddev_met_kStandard deviation in metallicity from 10 resampled spectrastat.stdev;phys.abund.Zfloatnullablechisq_kχ² of the Stellar Parameter Pipelinestat.fit.chi2floatnullableteff_irEffective temperature from infrared flux methodKphys.temperature.effectivefloatnullablee_teff_irError in the effective temperature from infrared flux methodKstat.error;phys.temperature.effectivefloatnullableir_directInfrared temperature method: IRFM -- Temperature derived from infrared flux method; CTRL -- Temperature computed via color-Teff relations; NO -- No temperature derivation possiblemeta.codecharnullablealpha_cAlpha-enhancement from chemical pipeline (log solar ratio; 'dex')phys.abundfloatnullablefrac_cFraction of spectrum used for calculation of abundancesstat.valuefloatnullableav_schlegelTotal Extinction in V-band from 1998ApJ...500..525Smagphys.absorptionfloatnullablen_gauss_fitNumber of components required for multi-Gaussian distance modulus fit.meta.numbershortnullablegauss_mean_1Gaussian number 1 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_1Gaussian number 1 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_2Gaussian number 2 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_2Gaussian number 2 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablegauss_mean_3Gaussian number 3 in the estimated PDF of the object distance, width.stat.fit.paramfloatnullablegauss_frac_3Gaussian number 3 in the estimated PDF of the object distance, weight.stat.fit.paramfloatnullablerep_flagTrue if the object was observed multiple timesmeta.code.qualbooleancluster_flagTrue if this was a targeted cluster observationmeta.code.qualbooleanid_tgasTGAS target designationmeta.id.crosslongnullable
rosatROSAT results -ROSAT was an orbiting x-ray observatory active in the 1990s. -We provide a table of all photons observed during ROSAT's all-sky -survey (RASS) as well as images of both survey and pointed observations. - -For ROSAT data products, see -http://www.xray.mpe.mpg.de/cgi-bin/rosat/rosat-surveyrosat.imagesMetadata for ROSAT pointed observations and the ROSAT All Sky Survey -(RASS) images115678accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsEpoch at midpoint of observationdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharindexednullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatindexednullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatindexednullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableseqnoROR sequence numbermeta.id;obsintindexedfollowupNumber of follow-up observation (0=first observation, NULL=mispointing)meta.code;obsintnullableobstypeType of data in the file (associated products available through datalink of by querying through seqno)meta.code;meta.filecharnullablepubdidPublisher dataset identifier (this lets you access datalink services and the like)meta.idcharnullabledlurlLink to a datalink document for this dataset, this lets you access associate data)meta.ref.urlcharnullable
rosat.photonsA table of x-ray photons detected by ROSAT88000000raj2000Right Ascension, equinox 2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination, equinox 2000.0degpos.eq.dec;meta.maindoubleindexednullabledetection_timeTime the photon was detected, in Julian years.yrtime.startdoubleindexednullableenergy_corEnergy of incoming photon (corrected) [keV]keVphys.energy;em.X-rayfloatindexednullableposition_errorTotal positional error, 1{sigma} arcsecarcsecstat.error;pos.eqfloatnullableglongGalactic longitudedegpos.galactic.lonfloatnullableglatGalactic latitudedegpos.galactic.latfloatnullablepulseht_channelChannel of the pulse height. This is a measure for the energy of the incoming photon, where one channel corresponds to about 10 eV; a pulse height channel of 127 thus indicates an incoming photon of about 1.3 keV.shortnullableexposure_timeROSAT cluster survey exposure timestime.duration;obs.exposurefloatnullablefield_idRASS field idmeta.id;obs.fieldshortnullableixX pixel coordinatepixelpos.cartesian.x;instr.detshortnullableiyY pixel coordinatepixelpos.cartesian.y;instr.detshortnullableidPhoton identifier (a combination of observation date and detector coordinates)meta.id;meta.mainlongindexedprimary
rrGAVO RegTAP Service -Tables containing the information in the IVOA Registry. To query -these tables, use `our TAP service`_. - -For more information and example queries, see the -`RegTAP specification`_. - -.. _our TAP service: /__system__/tap/run/info -.. _RegTAP specification: http://www.ivoa.net/documents/RegTAP/ivo://ivoa.net/std/RegTAP#1.1rr.alt_identifier An alternate identifier associated with this record. This can be a -resiource identifier like a DOI (in URI form, e.g., -doi:10.1016/j.epsl.2011.11.037), or a person identifier of a creator -(typically an ORCID in URI form, e.g., orcid:000-0000-0000-000X).xpath:/(curation/creator/|)altIdentifier63ivoidThe parent resource.xpath:/identifiercharindexednullablealt_identifierAn identifier for the resource or an entity related to the resource in URI form.charindexednullablerr.resourceivoidivoid
rr.authorities A mapping between the registries and the authorities they claim to -manage.ivo://ivoa.net/std/RegTAP#1.1142ivoidIVOID of the registry.charnullablemanaged_authorityAn authority this registry claims to serve.charindexedprimaryrr.registriesivoidivoid
rr.capability Pieces of behaviour of a resource.xpath:/capability/95817ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexAn arbitrary identifier of this capability within the resource.shortindexedprimarycap_typeThe type of capability covered here. If looking for endpoints implementing a certain standard, you should not use this column but rather match against standard_id.xpath:@xsi:typecharnullablecap_descriptionA human-readable description of what this capability provides as part of the over-all service.xpath:descriptionunicodeCharnullablestandard_idA URI for a standard this capability conforms to.xpath:@standardIDcharnullablerr.resourceivoidivoid
rr.g_num_stat An experimental table containing advanced statistics for numeric -table columns. This is only available for very few tables at this -point. - -Note that the values reported here may be estimates based on a subeset -of the table rows.ivo://ivoa.net/std/RegTAP#1.11052ivoidThe parent resource.xpath:/identifiercharnullabletable_indexIndex of the table this column belongs to.shortnameName of the column (see rr.table_column for more metadata).charindexednullablefill_factorAn estimate for the ratio of non-NULL values in this column to the number of rows in the table.floatnullablemin_valueThe largest value found in the column.floatnullablepercentile03An estimate for the value in the 3rd percentile of the column's distribution (for a Gaussian, roughly the lower limit of a 2σ interval).floatindexednullablemedianAn estimate for the median value (or 50th percentile) of the column's distributionfloatindexednullablepercentile97An estimate for the value in the 97th percentile of the column's distribution (for a Gaussian, roughly the upper limit of a 2σ interval).floatindexednullablemax_valueThe largest value found in the column.floatnullablerr.res_tableivoidivoidtable_indextable_index
rr.interface Information on access modes of a capability.xpath:/capability/interface/95935ivoidThe parent resource.xpath:/identifiercharindexedprimarycap_indexThe index of the parent capability.shortindexedintf_indexAn arbitrary identifier for the interfaces of a resource.shortindexedprimaryintf_typeThe type of the interface (vr:webbrowser, vs:paramhttp, etc).xpath:@xsi:typecharnullableintf_roleAn identifier for the role the interface plays in the particular capability. If the value is equal to "std" or begins with "std:", then the interface refers to a standard interface defined by the standard referred to by the capability's standardID attribute.xpath:@rolecharnullablestd_versionThe version of a standard interface specification that this interface complies with. When the interface is provided in the context of a Capability element, then the standard being refered to is the one identified by the Capability's standardID element.xpath:@versioncharnullablequery_typeHash-joined list of expected HTTP method (get or post) supported by the service.xpath:queryTypecharnullableresult_typeThe MIME type of a document returned in the HTTP response.xpath:resultTypecharnullablewsdl_urlThe location of the WSDL that describes this Web Service. If NULL, the location can be assumed to be the accessURL with '?wsdl' appended.xpath:wsdlURLcharnullableurl_useA flag indicating whether this should be interpreted as a base URL ('base'), a full URL ('full'), or a URL to a directory that will produce a listing of files ('dir').xpath:accessURL/@usecharnullableaccess_urlThe URL at which the interface is found.xpath:accessURLcharnullablemirror_urlSecondary access URLs of this interface, separated by hash characters.xpath:mirrorURLcharnullableauthenticated_onlyA flag for whether an interface is available for anonymous use (=0) or only authenticated clients are served (=1).shortsecurity_method_idThis column was mentioned in drafts of RegTAP 1.1 but was abandoned before RegTAP 1.1 REC. Do not use any more. This is just here to avoid a flag day for clients that experimentally used this column. This is always NULL here.not mappedcharnullablerr.capabilityivoidivoidcap_indexcap_index
rr.intf_param Input parameters for services.xpath:/capability/interface/param/3178ivoidThe parent resource.xpath:/identifiercharindexednullableintf_indexThe index of the interface this parameter belongs to.shortnameThe name of the parameter.xpath:namecharnullableucdA unified content descriptor that describes the scientific content of the parameter.xpath:ucdcharnullableunitThe unit associated with all values in the parameter.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this parameter represents.xpath:utypecharnullablestdIf 1, the meaning and use of this parameter is reserved and defined by a standard model. If 0, it represents a database-specific parameter that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the parameter.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this parameter contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullableparam_useAn indication of whether this parameter is required to be provided for the application or service to work properly (one of required, optional, ignored, or NULL).xpath:@usecharnullableparam_descriptionA free-text description of the parameter's contents.xpath:descriptionunicodeCharnullablerr.interfaceivoidivoidintf_indexintf_index
rr.registries Administrative table: publishing registries we harvest, together with -the dates of last full and incremental harvests.ivo://ivoa.net/std/RegTAP#1.153ivoidIVOID of the registry.charindexedprimaryaccessurlURL of the registry's OAI-PMH endpoint.charnullabletitleName of the registry.unicodeCharnullablelast_full_harvestDate and time of the last full harvest of the registry.charnullablelast_inc_harvestDate and time of the last incremental harvest of the registry.charnullable
rr.relationship Relationships between resources (like mirroring, derivation, serving -a data collection).xpath:/content/relationship/23702ivoidThe parent resource.xpath:/identifiercharindexednullablerelationship_typeThe type of the relationship; these terms are drawn from a controlled vocabulary and are DataCite-compatible.xpath:relationshipTypecharnullablerelated_idThe IVOA identifier for the resource referred to.xpath:relatedResource/@ivo-idcharnullablerelated_nameThe name of resource that this resource is related to.xpath:relatedResourcecharnullablerr.resourceivoidivoid
rr.res_date A date associated with an event in the life cycle of the resource. -This could be creation or update. The role column can be used to -clarify.xpath:/curation/23363ivoidThe parent resource.xpath:/identifiercharindexednullabledate_valueA date associated with an event in the life cycle of the resource.xpath:datecharnullablevalue_roleA string indicating what the date refers to, e.g., created, availability, updated. This value is generally drawn from a controlled vocabulary.xpath:date/@rolecharnullablerr.resourceivoidivoid
rr.res_detail XPath-value pairs for members of resource or capability and their -derivations that are less used and/or from VOResource extensions. The -pairs refer to a resource if cap_index is NULL, to the referenced -capability otherwise.ivo://ivoa.net/std/RegTAP#1.1215590ivoidThe parent resource.xpath:/identifiercharindexednullablecap_indexThe index of the parent capability; if NULL the xpath-value pair describes a member of the entire resource.shortnullabledetail_xpathThe xpath of the data item.charnullabledetail_value(Atomic) value of the member.unicodeCharnullablerr.resourceivoidivoid
rr.res_role Entities (persons or organizations) operating on resources: creators, -contacts, publishers, contributors.ivo://ivoa.net/std/RegTAP#1.195827ivoidThe parent resource.xpath:/identifiercharindexednullablerole_nameThe real-world name or title of a person or organization.unicodeCharindexednullablerole_ivoidAn IVOA identifier of a person or organization.charnullablestreet_addressA mailing address for a person or organization.unicodeCharnullableemailAn email address the entity can be reached at.charnullabletelephoneA telephone number the entity can be reached at.charnullablelogoURL pointing to a graphical logo, which may be used to help identify the entity.charnullablebase_roleThe role played by this entity; this is one of contact, publisher, contributor, or creator.charindexednullablerr.resourceivoidivoid
rr.res_schema Sets of tables related to resources.xpath:/tableset/schema/2137ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexAn arbitrary identifier for the res_schema rows belonging to a resource.shortindexedprimaryschema_descriptionA free text description of the tableset explaining in general how all of the tables are related.xpath:descriptionunicodeCharnullableschema_nameA name for the set of tables.xpath:name charnullableschema_titleA descriptive, human-interpretable name for the table set.xpath:titleunicodeCharnullableschema_utypeAn identifier for a concept in a data model that the data in this schema as a whole represent.xpath:utypecharnullablerr.resourceivoidivoid
rr.res_subject Topics, object types, or other descriptive keywords about the -resource.xpath:/content/55057ivoidThe parent resource.xpath:/identifiercharindexednullableres_subjectTopics, object types, or other descriptive keywords about the resource.xpath:subjectcharindexednullablerr.resourceivoidivoid
rr.res_table (Relational) tables that are part of schemata or resources.xpath:/(tableset/schema/|)table/60176ivoidThe parent resource.xpath:/identifiercharindexedprimaryschema_indexIndex of the schema this table belongs to, if it belongs to a schema (otherwise NULL).shortnullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharnullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharnullabletable_indexAn arbitrary identifier for the tables belonging to a resource.shortindexedprimarytable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharnullabletable_typeA name for the role this table plays. Recognized values include "output", indicating this table is output from a query; "base_table", indicating a table whose records represent the main subjects of its schema; and "view", indicating that the table represents a useful combination or subset of other tables. Other values are allowed.xpath:@typecharnullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullablenrowsAn estimate for the number of rows in the table.xpath:nrowslongnullablerr.resourceivoidivoid
rr.resource The resources (like services, data collections, organizations) -present in this registry.xpath:/24138ivoidUnambiguous reference to the resource conforming to the IVOA standard for identifiers.xpath:identifiercharindexedprimaryres_typeResource type (something like vg:authority, vs:catalogservice, etc).xpath:@xsi:typecharnullablecreatedThe UTC date and time this resource metadata description was created.xpath:@createdcharnullableshort_nameA short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).xpath:shortNamecharindexednullableres_titleThe full name given to the resource.xpath:titleunicodeCharindexednullableupdatedThe UTC date this resource metadata description was last updated.xpath:@updatedcharnullablecontent_levelA hash-separated list of content levels specifying the intended audience.xpath:content/contentLevelcharnullableres_descriptionAn account of the nature of the resource.xpath:content/descriptionunicodeCharindexednullablereference_urlURL pointing to a human-readable document describing this resource.xpath:content/referenceURLcharnullablecreator_seqThe creator(s) of the resource in the order given by the resource record author, separated by semicolons.xpath:curation/creator/nameunicodeCharindexednullablecontent_typeA hash-separated list of natures or genres of the content of the resource.xpath:content/typecharnullablesource_formatThe format of source_value. This, in particular, can be ``bibcode''.xpath:content/source/@formatcharnullablesource_valueA bibliographic reference from which the present resource is derived or extracted.xpath:content/sourceunicodeCharnullableres_versionLabel associated with creation or availablilty of a version of a resource.xpath:curation/versioncharnullableregion_of_regardA single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.degxpath:coverage/regionOfRegardfloatnullablewavebandA hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.xpath:coverage/wavebandcharnullablerightsA statement of usage conditions (license, attribution, embargo, etc).xpath:/rightscharnullablerights_uriA URI identifying a license the data is made available under.xpath:/rights/@rightsURIcharnullableharvested_fromIVOID of the registry this record came from.charnullablerr.registriesharvested_fromivoid
rr.stc_spatial The spatial coverage of resources. This table associates footprints -(ADQL geometries) with ivoids. The footprints are intended for -resource discovery; a reasonable expectation for the resolution thus -is something like a degree.xpath:/coverage/spatial16828ivoidThe parent resource.xpath:/identifiercharindexednullablecoverageA geometry representing the area a resource contains data for; this should be tight at least with a resolution of degrees.posxpath:.charnullableref_system_nameThe reference frame coverage is written in. This is currently reserved and fixed to NULL. Clients should always add a constraint to NULL for this to avoid matching non-celestial resources later.pos.framexpath:@framecharnullablerr.resourceivoidivoid
rr.stc_spectral The spectral coverage of resources, given as one or more intervals. -The total coverage is (a subset of) the union of all intervals given -for a resource. The spectral values are given as messenger energy.xpath:/coverage/spectral89ivoidThe parent resource.xpath:/identifiercharindexednullablespectral_startLower limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatspectral_endUpper limit of a messenger energy interval covered by the resource (for the solar system barycenter).Jxpath:.floatrr.resourceivoidivoid
rr.stc_temporal The temporal coverage of resources, given as one or more intervals. -The total coverage is (a subset of) the union of all intervals given -for a resource. All times are understood as MJD for TDB at the solar -system barycenter.xpath:/coverage/temporal104ivoidThe parent resource.xpath:/identifiercharindexednullabletime_startLower limit of a time interval covered by the resource.dxpath:.floattime_endUpper limit of a time interval covered by the resource.dxpath:.floatrr.resourceivoidivoid
rr.subject_uat res_subject mapped to the UAT. This is based on a manual mapping of -keywords found in 2020, where subjects not mappable were dropped. This -is a non-standard, local extension. Don't base your procedures on it, -we will tear it down once there is sufficient takeup of the UAT in the -VO.ivo://ivoa.net/std/RegTAP#1.151571ivoidThe parent resource.xpath:/identifiercharindexednullableuat_conceptTerm from http://www.ivoa.net/rdf/uat; most of these resulted from mapping non-UAT designations.charindexednullablerr.resourceivoidivoid
rr.table_column Metadata on columns of a resource's tables.xpath:/(tableset/schema/|)/table/column/1300000ivoidThe parent resource.xpath:/identifiercharindexednullabletable_indexIndex of the table this column belongs to.shortnameThe name of the column.xpath:namecharindexednullableucdA unified content descriptor that describes the scientific content of the column.xpath:ucdcharindexednullableunitThe unit associated with all values in the column.xpath:unitcharnullableutypeAn identifier for a role in a data model that the data in this column represents.xpath:utypecharnullablestdIf 1, the meaning and use of this column is reserved and defined by a standard model. If 0, it represents a database-specific column that effectively extends beyond the standard.xpath:@stdshortnullabledatatypeThe type of the data contained in the column.xpath:dataTypecharnullableextended_schemaAn identifier for the schema that the value given by the extended attribute is drawn from.xpath:dataType/@extendedSchemacharnullableextended_typeA custom type for the values this column contains.xpath:dataType/@extendedTypecharnullablearraysizeThe shape of the array that constitutes the value, e.g., 4, *, 4*, 5x4, or 5x*, as specified by VOTable.xpath:dataType/@arraysizecharnullabledelimThe string that is used to delimit elements of an array value when arraysize is not '1'.xpath:dataType/@delimcharnullabletype_systemThe type system used, as a QName with a canonical prefix; this will ususally be one of vs:simpledatatype, vs:votabletype, and vs:taptype.xpath:dataType/@xsi:typecharnullableflagHash-separated keywords representing traits of the column. Recognized values include "indexed", "primary", and "nullable".xpath:flagcharnullablecolumn_descriptionA free-text description of the column's contents.xpath:descriptionunicodeCharindexednullablerr.res_tableivoidivoidtable_indextable_index
rr.tap_table TAP-queriable tables.ivo://ivoa.net/std/RegTAP#1.1residIVOA identifier of the resource this table was taken from (where there is a dedicated resource containing this table in its tableset, that resource is preferred over a TAP service).charindexednullablesvcidIVOA identifier of the TAP service making this table queriable.charindexednullabletable_nameThe fully qualified name of the table. As per VODataService, this includes all catalog or schema prefixes needed to distinguish it in a query, and it comes with SQL delimiters where necessary.xpath:namecharindexednullabletable_titleA descriptive, human-interpretable name for the table.xpath:titleunicodeCharindexednullabletable_descriptionA free-text description of the table's contents.xpath:descriptionunicodeCharindexednullabletable_utypeAn identifier for a concept in a data model that the data in this table as a whole represent.xpath:utypecharnullable
rr.validationValidation levels for resources and capabilities.xpath:/(capability/|)validationLevel23685ivoidThe parent resource.xpath:/identifiercharindexednullablevalidated_byThe IVOA ID of the registry or organisation that assigned the validation level.xpath:validationLevel/@validatedBycharnullableval_levelA numeric grade describing the quality of the resource description, when applicable, to be used to indicate the confidence an end-user can put in the resource as part of a VO application or research study.xpath:validationLevelshortnullablecap_indexIf non-NULL, the validation only refers to the capability referenced here.shortnullablerr.resourceivoidivoidrr.resourceivoidivoid
sasmiralaSasmirala: Subarcsecond mid-infrared atlas of local AGN The Subarcsecond mid-infrared (MIR) atlas of local active galactic -nuclei (AGN) is a collection of all available N- and Q-band images -obtained at ground-based 8-meter class telescopes with public archives -(Gemini/Michelle, Gemini/T-ReCS, Subaru/COMICS, and VLT/VISIR). It -includes in total 895 images, of which 60% are perviously unpublished. -These correspond to 253 local AGN with a median redshift of 0.016. The -atlas contains the uniformly processed and calibrated images and -nuclear photometry obtained through Gauss and PSF fitting for all -objects and filters. This also includes measurements of the nuclear -extensions. In addition, the classifications of extended emission (if -present) and derived nuclear monochromatic 12 and 18 micron continuum -fluxes are available. Finally, flux ratios with the circumnuclear MIR -emission (measured by Spitzer) and total MIR emission of the galaxy -(measured by IRAS) are presented.sasmirala.objectsSasmirala Basic Object PropertiesBasic object properties and nuclear 12 and 18 micron continuum -fluxes/ratios.253nameCommon object namemeta.id;meta.maincharindexedprimaryraj2000Right Ascension J2000.0degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000.0degpos.eq.dec;meta.maindoubleindexednullableprodlinkLink to a web page with images, bibliography, and other details on the source.charnullablezRedshiftsrc.redshiftfloatnullabledDistanceMpcfloatnullableclsOptical classification (References for the collected optical AGN classifications are given in App. B of 2014MNRAS.439.1648A)src.classcharnullableu_agnClassification as AGN uncertain?meta.codebooleanbatidBAT ID from 9-month catalog (from Winter et al, 2009, 2009ApJ...690.1322W)meta.idintnullablen_extNuclear morphology at subarcsecond resolutionmeta.code;src.morphcharnullablelim12True if 12 µm flux was not detected. flu12 is a 3-sigma upper level in this case.meta.code;phot.fluxbooleanflu12Nuclear subarcsecond-scale monochromatic flux density at restframe 12 µmmJyphot.flux.density;em.IRfloatnullableerr121-σ uncertainty of the 12 µm continuum fluxmJystat.error;phot.flux;em.IRfloatnullablelim18True if 18 µm flux was not detected. flu18 is a 3-sigma upper level in this case.meta.code;phot.fluxbooleanflu18Nuclear subarcsecond-scale monochromatic flux density at restframe 18 µmmJyphot.flux.density;em.IRfloatnullableerr181-σ uncertainty of the 18 µm continuum fluxmJystat.error;phot.flux;em.IRfloatnullablephotparLink to detailed information on the photometry sources.meta.ref;photchardunrSize constraint on the nuclear unresolved emission in pc, which is set equal to the minimum PSF FWHM (major axis) measured for the objectpcphys.size;srcfloatnullablermedFlux ratio of nuclear to intermediate scale; the in Spitzer/IRS unresolved flux component is used as measure for the intermediate-scale emission.phot.flux;arith.ratiofloatnullablerlarFlux ratio of nuclear to large scale; the IRAS 12 µm flux is used as measure for the large-scale emission.phot.flux;arith.ratiofloatnullablepathcompInterally usedcharnullable
sasmirala.photparPhotometric parameters for all nuclear measurements.901nameCommon object namemeta.id;meta.maincharnullableraj2000Right Ascension J2000.0degpos.eq.ra;meta.maindoublenullabledej2000Declination J2000.0degpos.eq.dec;meta.maindoublenullablefilterFilter namemeta.id;instr.filtercharnullableaccrefAccess key for the datameta.ref.urlAccess.ReferencecharnullableprodlinkLink to a web page with images, bibliography, and other details on the source.charnullablew_obsFilter central wavelength (observing frame)umem.wl.central;instr.filterfloatnullablehwidthFilter half-width-half-maximumuminstr.bandwidthfloatnullableinstrInstrument used to obtain the datameta.id;instrcharnullablepfovPixel size of field of viewarcsec/pixphys.angSize;instr.pixelfloatnullableexptimeTotal exposure time on-sourcestime.duration;obs.exposurefloatnullablemodeChop and nod modeinstr.setupcharnullablecthrowChop throwarcsecinstr.paramfloatnullablecangleChop angledeginstr.paramfloatnullablerotaInstrument rotation angle, west of north.deginstr.param;pos.posAngfloatnullableproidObservation program IDmeta.id;obscharnullablecalnameCalibrator star namemeta.id;obs.calibcharnullablecalmjdMJD of observation of calibrator stardtime.epoch;obs.calibfloatnullabledateobsMJD of observationdtime.epoch;obsdoublenullableconvfConversion factor measured from the CalibrationmJy/ctphot.calibfloatnullableeconvf1-sigma uncertainty of the Conversion factormJy/ctstat.error;phot.calibfloatnullablecalfluCalibrator star fluxmJyphot.flux;obs.calibfloatnullablelimgaussIf True, the object was not detected using Gauss fitting or no matching calibrator star was available. In that case, F_Gauss represents a 3-sigma upper limit.meta.codebooleanfgaussNuclear flux measured through Gauss fittingmJyphot.flux;em.IRfloatnullableefgauss1-sigma uncertainty in nuclear flux measured through Gauss fittingmJystat.error;phot.flux;em.IRfloatnullablelimpsfIf True, the object was not detected using PSF fitting or no matching calibrator star was available. In that case, F_PSF represents a 3-sigma upper limit.meta.codebooleanfpsfNuclear flux measured through PSF fittingmJyphot.flux;em.IRfloatnullableefpsf1-sigma uncertainty in nuclear flux measured through PSF fittingmJystat.error;phot.flux;em.IRfloatnullablecalfmaCalibrator Star major axis FWHMarcsecphys.angSize;obs.calibfloatnullablecalfmiCalibrator Star minor axis FWHMarcsecphys.angSize;obs.calibfloatnullablecalpaCalibrator Star position angle, north over eastdegpos.posAng;obs.calibfloatnullablefwhmmaMajor axis FWHM (constrained to <=1arcsec) of the Gaussian fit of the target objectarcsecphys.angSize;srcfloatnullablefwhmmiMinor axis FWHM (constrained to <=1arcsec) of the Gaussian fit of the target objectarcsecphys.angSize;srcfloatnullablepaPosition Angle, north over east, of the Gaussian fit of the target objectdegpos.posAng;srcfloatnullable
sdssdr16SDSS DR16 Selection This is a redacted version of the SDSS DR16 table prepared for VizieR -(V/154/sdss16). It is mainly here to facilitate local matches; for -original SDSS-related research, it is probably better to somewhere -else. - -Over VizieR and SDSS, we are keeping most of the per-band values in -arrays to keep the column list manageable. Note that in ADQL, array -indexes are 1-based. - -We are trying to orient our column names on SDSS but use underscores -instead of camel-casing (e.g. spec_obj_id instead of SpecObjID), since -mixed-case identifiers in SQL is asking for trouble. - -To save space, we do not keep psf-based classifications, per-band -offsets, spectrum metadata, and USNO-related information in this -table. Let the operators know if you need any of that.sdssdr16.main This is a redacted version of the SDSS DR16 table prepared for VizieR -(V/154/sdss16). It is mainly here to facilitate local matches; for -original SDSS-related research, it is probably better to somewhere -else. - -Over VizieR and SDSS, we are keeping most of the per-band values in -arrays to keep the column list manageable. Note that in ADQL, array -indexes are 1-based. - -We are trying to orient our column names on SDSS but use underscores -instead of camel-casing (e.g. spec_obj_id instead of SpecObjID), since -mixed-case identifiers in SQL is asking for trouble. - -To save space, we do not keep psf-based classifications, per-band -offsets, spectrum metadata, and USNO-related information in this -table. Let the operators know if you need any of that.1300000000obj_idSDSS unique object identifiermeta.id;meta.mainlongindexedprimaryraRight Ascension of the object (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledecDeclination of the object (ICRS)degpos.eq.dec;meta.maindoubleindexednullablera_errMean error on raarcsecstat.error;pos.eq.rafloatnullabledec_errMean error on decarcsecstat.error;pos.eq.decfloatnullablepm_raProper motion along Right Ascensionmas/yrpos.pm;pos.eq.rafloatnullablee_pm_raMean error on pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepm_decProper motion along Declinationmas/yrpos.pm;pos.eq.decfloatnullablepm_dec_errMean error on pmDE.mas/yrstat.error;pos.pm;pos.eq.decfloatnullablepm_sig_raRMS residual of proper motion fit in RA.masstat.fit.residualfloatnullablepm_sig_decRMS residual of proper motion fit in Dec.masstat.fit.residualfloatnullableuModel magnitude in u filter AB scalemagphot.mag;em.opt.Ufloatnullableerr_uModel magnitude in u filter AB scalemagphot.mag;em.opt.UfloatnullablegModel magnitude in g filter AB scalemagphot.mag;em.opt.Vfloatnullableerr_gModel magnitude in g filter AB scalemagphot.mag;em.opt.VfloatnullablerModel magnitude in r filter AB scalemagphot.mag;em.opt.Rfloatnullableerr_rModel magnitude in r filter AB scalemagphot.mag;em.opt.RfloatnullableiModel magnitude in i filter AB scalemagphot.mag;em.opt.Ifloatnullableerr_iModel magnitude in i filter AB scalemagphot.mag;em.opt.IfloatnullablezModel magnitude in z filter AB scalemagphot.mag;em.opt.Ifloatnullableerr_zModel magnitude in z filter AB scalemagphot.mag;em.opt.Ifloatnullablefield_idThe field this object is in.meta.notelongmodePhoto mode (1=primary, 2=secondary, 3=family, 4=outside)meta.code.classshortclassType of object (3=galaxy, 6=star)src.classshortindexedcleanClean photometry flag (1=clean; 0=unclean)meta.codeshortphoto_flagsPhoto Object Attribute flagsmeta.code.errorlongpsfmagsArray of PSF magnitudes, in ugriz sequencemagphot.magfloatnullablepsfmag_errsArray of the errors of the PSF magnitudes, in ubriz sequencemagstat.error;phot.magfloatnullablepetmagsArray of Petrosian magnitudes, in ugriz sequencemagphot.magfloatnullablepetmag_errsArray of the errors Petrosian magnitudes, in ugriz sequencemagphot.magfloatnullablepetradsArray of Petrosian radii, in ugriz sequencearcsecphys.angSize;srcfloatnullablepetrad_errsArray of Petrosian radii, in ugriz sequencearcsecstat.error;phys.angSize;srcfloatnullabledev_radsArray of de Vaucouleurs fit radii, in ugriz sequencearcsecphys.angSize;srcfloatnullabledev_absArray of de Vaucouleurs fit b/a ratios, in ugriz sequencephys.size.axisRatiofloatnullabledev_phiArray of position angles of de Vaucouleurs fits in ugriz sequence (warning: anything smaller than 0 in here must be considered NULL).degpos.posAngfloatnullableflagsArray of detection flags, in ugriz sequencemeta.codelongnullabletypesArray of phototypes (6=Star ; 3=galaxy) in ugriz sequencesrc.class.starGalaxyshortnullableparent_idPointer to parent (if object deblended)meta.id.parentlongnullablespec_zSpectroscopic final redshift (when SpObjID>0)src.redshiftfloatindexednullablespec_z_errMean error on spec_z (negative for bad fit)stat.errorfloatnullablespec_z_warningWarning flag on redshift.meta.codeshortnullablespec_classSpectroscopic class: "GALAXY"; "QSO"; "STAR"meta.code.class;pos.parallax.spectcharnullablespec_sub_classSpectroscopic subclass.src.classcharnullablespec_vel_dispVelocity dispersionkm/sphys.veloc.dispersionfloatnullablespec_vel_disp_errMean error on spec_vel_dispkm/sstat.errorfloatnullablespec_sn_medianMedian signal-to-noise over all good pixels.em.wl.central;stat.medianfloatnullablephotoz_zPhotometric redshift estimated by robust fit to nearest neighbors in a reference setsrc.redshiftfloatindexednullablephotoz_z_errEstimated error of the photometric redshiftstat.errorfloatnullablephotoz_nn_avg_zAverage redshift of the nearest neighbors; if significantly different from photoz_z this might be a better estimate than photoz_zsrc.redshift.photfloatnullablephotoz_chisqChi-square value for the minimum chi-square template fitstat.valuefloatnullablefield_qualityQuality of the observation: 1=bad; 2=barely acceptable; 3=goodmeta.code.qual;obs.param;obsshortfield_mjdsArray of dates of observation per ugriz banddtime.epochdoublenullablesdss_idSDSS object identifier (run-rerun-camcol-field-object)meta.idcharnullablespectral_idSpectroscopic Plate-MJD-Fiber identifier (plate-mjd-fiberID)meta.idcharnullable
sdssdr7SDSS DR7 PhotoObjAll -This is the result of the query:: - - select - objID, field.run, field.rerun, field.camcol, field.fieldId, - obj, ra, dec, raErr, decErr, raDecCorr, - offsetRa_u, offsetRa_g, offsetRa_r, offsetRa_i, offsetRa_z, - offsetDec_u, offsetDec_g, offsetDec_r, offsetDec_i, offsetDec_z, - u, g, r, i, z, err_u, err_g, err_r, err_i, err_z, - mjd_u, mjd_g, mjd_r, mjd_i, mjd_z - from - PhotoObjAll - join - field - on (field.fieldId=PhotoObjAll.fieldId) - -on SDSS DR7, kindly provided by the Potsdam mirror. All angular -quantities are given in degrees here.sdssdr7.sources -This is the result of the query:: - - select - objID, field.run, field.rerun, field.camcol, field.fieldId, - obj, ra, dec, raErr, decErr, raDecCorr, - offsetRa_u, offsetRa_g, offsetRa_r, offsetRa_i, offsetRa_z, - offsetDec_u, offsetDec_g, offsetDec_r, offsetDec_i, offsetDec_z, - u, g, r, i, z, err_u, err_g, err_r, err_i, err_z, - mjd_u, mjd_g, mjd_r, mjd_i, mjd_z - from - PhotoObjAll - join - field - on (field.fieldId=PhotoObjAll.fieldId) - -on SDSS DR7, kindly provided by the Potsdam mirror. All angular -quantities are given in degrees here.590000000objidUnique SDSS identifier composed from [skyVersion,rerun,run,camcol,field,obj].meta.id;meta.mainlongrunRun numbermeta.id;obsshortrerunRerun numbermeta.id;obsshortcamcolCamera columnmeta.id;instrshortfieldidField numbermeta.id;obs.fieldlongobjThe object id within a field. Usually changes between reruns of the same field.meta.idshortraJ2000 right ascension (r')degpos.eq.ra;meta.maindoubleindexednullabledecJ2000 declination (r')degpos.eq.dec;meta.maindoubleindexednullableraerrError in RAdegstat.error;pos.eq.ra;meta.mainfloatnullabledecerrError in Decdegstat.error;pos.eq.dec;meta.mainfloatnullableradeccorrRA/dec correlationstat.correlation;pos.eq.ra;pos.eq.decfloatnullableoffsetra_uFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_uFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullableuMagnitude in u band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Ufloatnullableerr_uError in corresponding magnitudemagstat.error;phot.mag;em.opt.Ufloatnullableepoch_uDate of observation in u bandyrtime.epochfloatnullableoffsetra_gFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_gFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullablegMagnitude in g band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Vfloatnullableerr_gError in corresponding magnitudemagstat.error;phot.mag;em.opt.Vfloatnullableepoch_gDate of observation in g bandyrtime.epochfloatnullableoffsetra_rFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_rFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullablerMagnitude in r band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Rfloatnullableerr_rError in corresponding magnitudemagstat.error;phot.mag;em.opt.Rfloatnullableepoch_rDate of observation in r bandyrtime.epochfloatnullableoffsetra_iFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_iFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullableiMagnitude in i band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Ifloatnullableerr_iError in corresponding magnitudemagstat.error;phot.mag;em.opt.Ifloatnullableepoch_iDate of observation in i bandyrtime.epochfloatnullableoffsetra_zFilter position RA minus final RA, cos(dec) applieddegpos.eq.ra;arith.difffloatnullableoffsetdec_zFilter position Dec minus final Decdegpos.eq.dec;arith.difffloatnullablezMagnitude in z band, better of deVaucouleurs and exponential fitsmagphot.mag;em.opt.Ifloatnullableerr_zError in corresponding magnitudemagstat.error;phot.mag;em.opt.Ifloatnullableepoch_zDate of observation in z bandyrtime.epochfloatnullable
smakcedA Near-infrared Census of the Multicomponent Stellar Structure of -Early-type Dwarf Galaxies in the Virgo Cluster -The Stellar content, MAss and Kinematics of Cluster Early-type Dwarf -galaxies (SMAKCED_) project is a survey of 121 Virgo cluster early type -galaxies. This service publishes deep near-infrared (H band) images -obtained by SMAKCED together with `resulting decompositions`_ and other -properties of the galaxies in the sample. - -.. _SMAKCED: http://smakced.net -.. _resulting decompositions: http://smakced.net/data.htmlsmakced.mainSMAKCED infrared images and derived properties of early-type dwarf -galaxies in the Virgo cluster.119accrefAccess key for the datameta.ref.urlAccess.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimeAccess.FormatcharnullableaccsizeSize of the data in bytesbyteVOX:Image_FileSizeAccess.SizelongnullablecenteralphaApproximate center of image, RAdegpos.eq.radoubleindexednullablecenterdeltaApproximate center of image, Decdegpos.eq.decdoubleindexednullableimagetitleSynthetic name of the imagemeta.titlecharnullableinstidIdentifier of the originating instrumentmeta.id;instrcharnullabledateobsApproximate observation date (essentially, month and year should be about right). NULL for archival materialdtime;obs.exposuredoublenullablenaxesNumber of axes in datapos.wcs.naxesintnullablepixelsizeNumber of pixels along each of the axespixelpos.wcs.naxisintnullablepixelscaleThe pixel scale on each image axisdeg/pixelpos.wcs.scalefloatnullablerefframeCoordinate system reference framepos.framecharnullablewcs_equinoxEquinox of the given coordinatesyrtime.equinoxfloatnullablewcs_projectionFITS WCS projection typepos.wcs.ctypecharnullablewcs_refpixelWCS reference pixelpixelpos.wcs.crpixfloatnullablewcs_refvaluesWorld coordinates at WCS reference pixeldegpos.wcs.crvaldoublenullablewcs_cdmatrixFITS WCS CDij matrixdeg/pixelpos.wcs.cdmatrixfloatnullablebandpassidFreeform name of the bandpass usedinstr.bandpasscharnullablebandpassunitUnit of bandpass specifications (always m).charnullablebandpassrefvalCharacteristic quantity for the bandpass of the imageminstr.bandpass;stat.medianfloatnullablebandpasshiUpper limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.maxfloatnullablebandpassloLower limit of the bandpass (in BandPass_Unit units)minstr.bandpass;stat.minfloatnullablepixflagsFlags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlymeta.codecharnullablecoverageField covered by the imagedegdoubleindexednullableobjectCommon name of the observed galaxy.meta.id;meta.maincharraj2000ICRS RA of galaxy center from asymmetry centering (unless specified otherwise in remarks).degpos.eq.ra;meta.maindoublenullabledej2000ICRS Declination of galaxy center from asymmetry centering (unless specified otherwise in remarks).degpos.eq.dec;meta.maindoublenullableexptimeTotal integration time for the object (sum of exposure times of all images stacked; note that different telescopes were in use).stime.duration;obs.exposurefloatnullableseeingEstimate for the seeing at observation time.arcsecinstr.obsty.seeingfloatnullablesnrSignal to noise ratio for a pixel at 2 r_e.stat.snrfloatnullablehmagTotal H-band magnitude of the galaxyphot.mag;em.ir.Hfloatnullabler_eEffective radius of the galaxy (semi-major axis of half-light aperture in H).arcsecphys.angSizefloatnullableb_aAxis raio at 2 r_ephys.angSize;arith.ratiofloatnullableconcentrationConcentration index 5 log_80/r_20 as in 2000AJ....119.2645Bphys.size;arith.ratiofloatnullablerho10Local projected number density of cluster galaxies. (see Appendix D in the source)log(deg**-2)src.densityfloatnullableremarksMorphological features from 2006AJ....132.2432L and other remarksmeta.notecharnullablemoreinfoBibcodes of papers containing more information.meta.refcharnullablestructgroupStructural Group (see 2012ApJ...745L..24J) resulting from the decomposition.meta.code.classcharnullablesimp_mIntegrated H-band brightness, simple modelmagphot.mag;em.ir.Hfloatnullablesimp_rcHalf-light radius, simple modelarcsecphys.angSize;srcfloatnullablesimp_nSérsic index, simple modelstat.fit.paramfloatnullablesimp_b_aAxis ratio, simple modelphys.angSize;arith.ratiofloatnullableinner_mIntegrated H-band brightness, inner componentmagphot.mag;em.ir.Hfloatnullableinner_rcHalf-light radius, inner componentarcsecphys.angSize;srcfloatnullableinner_nSérsic index, inner componentstat.fit.paramfloatnullableinner_b_aAxis ratio, inner componentphys.angSize;arith.ratiofloatnullableouter_mIntegrated H-band brightness, global/outer componentmagphot.mag;em.ir.Hfloatnullableouter_rcHalf-light radius, global/outer componentarcsecphys.angSize;srcfloatnullableouter_nSérsic index, global/outer componentstat.fit.paramfloatnullableouter_b_aAxis ratio, global/outer componentphys.angSize;arith.ratiofloatnullablesimpdec_rffResidual flux fraction (2006ApJ...644...30B) for the single decompositionstat.fit.goodnessfloatnullablesimpdec_eviExcess variance index (2011MNRAS.411.2439H) for single decompositionstat.fit.goodnessfloatnullablefinaldec_rffResidual flux fraction (2006ApJ...644...30B) for the final decompositionstat.fit.goodnessfloatnullablefinaldec_eviExcess variance index (2011MNRAS.411.2439H) for final decompositionstat.fit.goodnessfloatnullablecompmorphAdditional information on decomposition.meta.note;src.morphcharnullable
speciesAtomic and Molecular Species Names A TAP-queriable database of common names of molecules and their -InChIs. This is an experimental copy of http://species.vamdc.org -created in the context of the LineTAP effort, augmented with names -found in the CASA line list. You will probably want to query this -using SQL wildcards (% and _) and the ILIKE operator.species.main A TAP-queriable database of common names of molecules and their -InChIs. This is an experimental copy of http://species.vamdc.org -created in the context of the LineTAP effort, augmented with names -found in the CASA line list. You will probably want to query this -using SQL wildcards (% and _) and the ILIKE operator.ivo://ivoa.net/std/linetap#species-1.0inchikeyInChIKey of this speciescharindexednullableinchiInChI of this speciescharnullablenameA common name of this speciesunicodeCharindexednullableformulaChemical formula of this speciescharindexednullablestoichiometricformulaChemical formula of this speciescharnullablesource_idVAMDC identifier of the origin of this mappingcharnullable
spm4Yale/San Juan SPM4 Catalog The SPM4 Catalog contains absolute proper motions, celestial -coordinates, and B,V photometry for 103,319,647 stars and galaxies -between the south celestial pole and -20 degrees declination. The -catalog is roughly complete to V=17.5. It is based on photographic and -CCD observations taken with the Yale Southern Observatory's -double-astrograph at Cesco Observatory in El Leoncito, Argentina.spm4.main The SPM4 Catalog contains absolute proper motions, celestial -coordinates, and B,V photometry for 103,319,647 stars and galaxies -between the south celestial pole and -20 degrees declination. The -catalog is roughly complete to V=17.5. It is based on photographic and -CCD observations taken with the Yale Southern Observatory's -double-astrograph at Cesco Observatory in El Leoncito, Argentina.110000000spmidUnique SPM4 id (field number + input catalog line number)meta.id;meta.maincharindexednullableraj2000Right Ascension (ICRS, epoch=2000.0)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (ICRS, epoch=2000.0)degpos.eq.dec;meta.maindoubleindexednullablee_raj2000Expected uncertainty in Right Ascension at mean epochdegstat.error;pos.eq.ra;meta.mainfloatnullablee_dej2000Expected uncertainty in Declination at mean epochdegstat.error;pos.eq.dec;meta.mainfloatnullablepmraAbsolute proper motion in RA (mu_alpha*cos(Dec))deg/yrpos.pm;pos.eq.rafloatnullablepmdeAbsolute proper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablee_pmraExpected uncertainty in proper motion in RA (mu_alpha*cos(Dec)), at mean epochdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeExpected uncertainty in proper motion in Declination, at mean epoch.deg/yrstat.error;pos.pm;pos.eq.decfloatnullablemagbB magnitudemagphot.mag;em.opt.BfloatnullablemagvV magnitudemagphot.mag;em.opt.Vfloatindexednullablei_magbsource flag for B magnitudemeta.code;phot.mag;em.opt.Bchari_magvsource flag for V magnitudemeta.code;phot.mag;em.opt.VcharmeanepWeighted mean epochyrtime.epochfloatnullableep1Weighted mean epoch of first observationyrtime.epochfloatnullableep2Weighted mean epoch of second observationyrtime.epochfloatnullablenplates1Number of 1st epoch plates usedmeta.number;instr.plateshortnplates2Number of 2nd epoch plates usedmeta.number;instr.plateshortnccd2Number of 2nd epoch ccd frames usedmeta.numbershorti_galGalaxy/extended-source flagsrc.class.starGalaxyshorti_catCode for the input catalogmeta.codeshortmagjJ selected default magnitude from 2MASSmagphot.mag;em.IR.JfloatnullablemaghH selected default magnitude from 2MASSmagphot.mag;em.IR.HfloatnullablemagkK_s selected default magnitude from 2MASSmagphot.mag;em.IR.Kfloatnullable
supercosmosSuperCOSMOS Sources The SuperCOSMOS data primarily originate from scans of the UK Schmidt -and Palomar POSS II blue, red and near-IR sky surveys. The ESO Schmidt -R (dec < -17.5) and Palomar POSS-I E (dec > -17.5) surveys have also -been scanned and provide an early (1st) epoch red measurement. -Mirrored here is the source table containing four-plate multi-colour, -multi-epoch data which are merged into a single source catalogue for -general science exploitation. Within the GAVO DC, some column names -have been adapted to local customs (primarily positions, proper -motions).supercosmos.sources The SuperCOSMOS data primarily originate from scans of the UK Schmidt -and Palomar POSS II blue, red and near-IR sky surveys. The ESO Schmidt -R (dec < -17.5) and Palomar POSS-I E (dec > -17.5) surveys have also -been scanned and provide an early (1st) epoch red measurement. -Mirrored here is the source table containing four-plate multi-colour, -multi-epoch data which are merged into a single source catalogue for -general science exploitation. Within the GAVO DC, some column names -have been adapted to local customs (primarily positions, proper -motions).1900000000objidSuperCOSMOS identifier of merged sourcemeta.id;meta.mainlongobjidbobjID for B band detection merged into this objectmeta.id.assoclongnullableobjidr1objID for R1 band detection merged into this objectmeta.id.assoclongnullableobjidr2objID for R2 band detection merged into this objectmeta.id.assoclongnullableobjidiobjID for I band detection merged into this objectmeta.id.assoclongnullableepochEpoch of position (variance weighted mean epoch of available measures)yrtime.epochfloatnullableraj2000Mean RA, computed from detections merged in this cataloguedegpos.eq.ra;meta.maindoubleindexednullabledej2000Mean Dec, computed from detections merged in this cataloguedegpos.eq.dec;meta.maindoubleindexednullablesigraUncertainty in RA (formal random error not including systematic errors)degstat.error;pos.eq.rafloatnullablesigdecUncertainty in Dec (formal random error not including systematic errors)degstat.error;pos.eq.rafloatnullablepmraProper motion in RA directiondeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Dec directiondeg/yrpos.pm;pos.eq.decfloatnullablee_pmraError on proper motion in RA directiondeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeError on proper motion in Dec directiondeg/yrstat.error;pos.pm;pos.eq.decfloatnullablechi2Chi-squared value of proper motion solutionstat.fit.chi2floatnullablenplatesNo. of plates used for this proper motion measurementmeta.number;obsshortclassmagbB band magnitude selected by B image classmagphot.mag;em.opt.Bfloatindexednullableclassmagr1R1 band magnitude selected by R1 image classmagphot.mag;em.opt.Rfloatnullableclassmagr2R2 band magnitude selected by R2 image classmagphot.mag;em.opt.RfloatnullableclassmagiI band magnitude selected by I image classmagphot.mag;em.opt.IfloatindexednullablegcormagbB band magnitude assuming object is galaxymagphot.mag;em.opt.Bfloatnullablegcormagr1R1 band magnitude assuming object is galaxymagphot.mag;em.opt.Rfloatnullablegcormagr2R2 band magnitude assuming object is galaxymagphot.mag;em.opt.RfloatnullablegcormagiI band magnitude assuming object is galaxymagphot.mag;em.opt.IfloatnullablescormagbB band magnitude assuming object is starmagphot.mag;em.opt.Bfloatnullablescormagr1R1 band magnitude assuming object is starmagphot.mag;em.opt.Rfloatnullablescormagr2R2 band magnitude assuming object is starmagphot.mag;em.opt.RfloatnullablescormagiI band magnitude assuming object is starmagphot.mag;em.opt.IfloatnullablemeanclassEstimate of image class based on unit-weighted mean of individual classessrc.class.starGalaxyshortclassbImage classification from B band detectionsrc.class;em.opt.Bshortnullableclassr1Image classification from R1 band detectionsrc.class;em.opt.Rshortnullableclassr2Image classification from R2 band detectionsrc.class;em.opt.RshortnullableclassiImage classification from I band detectionsrc.class;em.opt.IshortnullableellipbEllipticity of B band detectionsrc.ellipticityfloatnullableellipr1Ellipticity of R1 band detectionsrc.ellipticity;em.opt.Rfloatnullableellipr2Ellipticity of R2 band detectionsrc.ellipticity;em.opt.RfloatnullableellipiEllipticity of I band detectionsrc.ellipticity;em.opt.IfloatnullablequalbBitwise quality flag from B band detectionmeta.code.qual;em.opt.Bintnullablequalr1Bitwise quality flag from R1 band detectionmeta.code.qual;em.opt.Rintnullablequalr2Bitwise quality flag from R2 band detectionmeta.code.qual;em.opt.RintnullablequaliBitwise quality flag from I band detectionmeta.code.qual;em.opt.IintnullableblendbBlend flag from B band detectionmeta.code.qual;em.opt.Bintnullableblendr1Blend flag from R1 band detectionmeta.code.qual;em.opt.Rintnullableblendr2Blend flag from R2 band detectionmeta.code.qual;em.opt.RintnullableblendiBlend flag from I band detectionmeta.code.qual;em.opt.IintnullableprfstatbProfile statistic from B band detectionsrc.class.starGalaxyfloatnullableprfstatr1Profile statistic from R1 band detectionsrc.class.starGalaxy;em.opt.Rfloatnullableprfstatr2Profile statistic from R2 band detectionsrc.class.starGalaxy;em.opt.RfloatnullableprfstatiProfile statistic from I band detectionsrc.class.starGalaxy;em.opt.RfloatnullableebmvThe estimated foreground reddening at this position from Schlegel et al. (1998)magphys.absorptionfloatnullable
tap_schema GAVO Data Center's Table Access Protocol (TAP) service with -table metadata.tap_schema.columnsColumns in tables available for ADQL querying.table_nameFully qualified table namecharindexedprimarycolumn_nameColumn namecharindexedprimarydescriptionBrief description of columnunicodeCharnullableunitUnit in VO standard formatcharnullableucdUCD of column if anycharnullableutypeUtype of column if anycharnullabledatatypeADQL datatypecharnullablearraysizeArraysize in VOTable notationcharnullablextypeVOTable extended type information (for special interpretation of data content, e.g., timestamps or points)charnullable"size"Legacy length (ignore if you can).intnullableprincipalIs column principal?intindexedIs there an index on this column?intstdIs this a standard column?intsourcerdId of the originating rd (local information)charnullablecolumn_index1-based index of the column in database order.shortnullabletap_schema.tablestable_nametable_name
tap_schema.groupsColumns that are part of groups within tables available for ADQL -querying.table_nameFully qualified table namecharnullablecolumn_nameName of a column belonging to the groupcharnullablecolumn_utypeutype the column within the groupcharnullablegroup_nameName of the groupcharnullablegroup_utypeutype of the groupcharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablestable_nametable_name
tap_schema.key_columnsColumns participating in foreign key relationships between tables -available for ADQL querying.key_idKey identifier from TAP_SCHEMA.keyscharnullablefrom_columnKey column name in the from tablecharnullabletarget_columnKey column in the target tablecharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.keyskey_idkey_id
tap_schema.keysForeign key relationships between tables available for ADQL querying.key_idUnique key identifiercharindexedprimaryfrom_tableFully qualified table namecharnullabletarget_tableFully qualified table namecharnullabledescriptionDescription of this keyunicodeCharnullableutypeUtype of this keycharnullablesourcerdId of the originating rd (local information)charnullabletap_schema.tablesfrom_tabletable_nametap_schema.tablestarget_tabletable_name
tap_schema.schemasSchemas containing tables available for ADQL querying.schema_nameFully qualified schema namecharindexedprimarydescriptionBrief description of the schemaunicodeCharnullableutypeutype if schema corresponds to a data modelcharnullableschema_indexSuggested position this schema should take in a sorted list of schemas from this data center.intnullable
tap_schema.tablesTables available for ADQL querying.schema_nameFully qualified schema namecharnullabletable_nameFully qualified table namecharindexedprimarytable_typeOne of: table, viewcharnullabledescriptionBrief description of the tableunicodeCharnullableutypeutype if the table corresponds to a data modelcharnullabletable_indexSuggested position this table should take in a sorted list of tables from this data centerintnullablesourcerdId of the originating rd (local information)charnullablenrowsThe approximate size of the table in rowslongnullabletap_schema.schemasschema_nameschema_name
taptestData for regression teststaptest.mainA table containing nonsensical data. Do not use except for -experiments.radegpos.eq.ra;meta.mainfloatindexednullablededegpos.eq.dec;meta.mainfloatindexednullablespectralinstr.bandpasscharnullable
tenpcThe 10 parsec sample in the Gaia era A catalogue of 541 nearby (within 10pc of the sun) stars, brown -dwarfs, and confirmed exoplanets in 336 systems, as well 21 -candidates, compiled from SIMBAD and several other sources. Where -available, astrometry and photometry from Gaia eDR3 has been inserted.tenpc.main A catalogue of 541 nearby (within 10pc of the sun) stars, brown -dwarfs, and confirmed exoplanets in 336 systems, as well 21 -candidates, compiled from SIMBAD and several other sources. Where -available, astrometry and photometry from Gaia eDR3 has been inserted.562nb_objRunning number for object, ordered by increasing distancemeta.id;meta.mainshortnb_sysRunning number for system, ordered by increasing distancemeta.id.parentshortsystem_nameName of the systemmeta.id.parentcharnullableobj_catOne of Star (*), LM (low mass star), BD (brown dwarf), WD (white dwarf), or Planetmeta.code.classcharnullableobj_nameAdopted name of the objectmeta.idcharnullableraRight ascension at epoch (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledecDeclination at epoch (ICRS)degpos.eq.dec;meta.maindoubleindexednullableepochEpoch for ra and decyrtime.epochfloatnullableparallaxTrigonometric parallaxmaspos.parallax.trigdoublenullableparallax_errorParallax uncertaintymasstat.error;pos.parallaxdoublenullableparallax_bibcodeReference for the parallax; missing values here mean the parallax is taken from another member of the systemmeta.bib;pos.parallaxcharnullablepmraProper motion in right ascensionmas/yrpos.pm;pos.eq.radoublenullablepmra_errorProper motion uncertainty in right ascensionmas/yrstat.error;pos.pm;pos.eq.radoublenullablepmdecProper motion in declinationmas/yrpos.pm;pos.eq.decdoublenullablepmdec_errorProper motion uncertainty in declinationmas/yrstat.error;pos.pm;pos.eq.decdoublenullablepm_bibcodeReference for the proper motion; missing values here mean that the proper motion was taken from another member of the systemmeta.ref;pos.pm;pos.eq.racharnullablervLine-of-sight velocitykm/sspect.dopplerVelocfloatnullablerv_errorLine-of-sight velocity uncertaintykm/sstat.error;spect.dopplerVelocfloatnullablerv_bibcodeReference for the line-of-sight velocitymeta.ref;spect.dopplerVeloccharnullablesp_typeSpectral typesrc.sptypecharnullablesp_bibcodeReference for spectral typemeta.ref;src.sptypecharnullablesp_methodMethod used to derive the spectral typemeta.codecharnullableg_codeSource of the value of the G magnitude (see note)meta.code;phot.mag;em.opt.Vshortnullablemag_gGaia G band magnitude measured (when g_code is 2 or 3)magphot.mag;em.opt.Vdoublenullablemag_g_estimateEstimated Gaia G band magnitude (when g_code is not 2 or 3)magphot.mag;em.opt.Vfloatnullablemag_gbpGaia BP band magnitudephot.mag;em.opt.Bdoublenullablemag_grpGaia RP band magnitudephot.mag;em.opt.Rdoublenullablemag_uMagnitude in Umagphot.mag;em.opt.Ufloatnullablemag_bMagnitude in Bmagphot.mag;em.opt.Bfloatnullablemag_vMagnitude in Vmagphot.mag;em.opt.Vfloatnullablemag_rMagnitude in Rmagphot.mag;em.opt.Rfloatnullablemag_iMagnitude in Imagphot.mag;em.opt.Ifloatnullablemag_jMagnitude in Jmagphot.mag;em.ir.Jfloatnullablemag_hMagnitude in Hmagphot.mag;em.ir.Hfloatnullablemag_kMagnitude in Kmagphot.mag;em.ir.Kfloatnullablesystem_bibcodeReference for multiplicity or exoplanetsmeta.refcharnullableexoplanet_countNumber of confirmed exoplanetsmeta.numbershortnullablegaia_dr2Gaia DR2 identifiermeta.id.crosslongnullablegaia_edr3Gaia EDR3 identifiermeta.id.crosslongnullablesimbad_nameName resolved by SIMBADmeta.id.crosscharnullablecommon_nameCommon namemeta.idcharnullablegjGliese and Jahreiß catalogue identifiermeta.id.crosscharnullablehdHenry Draper catalogue identifiermeta.id.crosscharnullablehipHipparcos catalogue identifiermeta.id.crosscharnullablecommentAdditional comments on exoplanets, multiplicity, etcmeta.notecharnullable
tgasTGAS catalogue This table is a subset of GaiaSource comprising those stars in the -Hipparcos and Tycho-2 Catalogues for which a full 5-parameter -astrometric solution has been possible in Gaia Data Release 1. This is -possible because the early Hipparcos epoch positions break some -degeneracies due to the limited Gaia time coverage. This table -contains a substantial fraction of the around 2.5 million stars in the -Hipparcos and Tycho-2 catalogue. Many stars have been excluded due to -several reasons, such as saturation, cross-match errors or bad -astrometric solution. All rows have Gaia solution id -1635378410781933568.tgas.main This table is a subset of GaiaSource comprising those stars in the -Hipparcos and Tycho-2 Catalogues for which a full 5-parameter -astrometric solution has been possible in Gaia Data Release 1. This is -possible because the early Hipparcos epoch positions break some -degeneracies due to the limited Gaia time coverage. This table -contains a substantial fraction of the around 2.5 million stars in the -Hipparcos and Tycho-2 catalogue. Many stars have been excluded due to -several reasons, such as saturation, cross-match errors or bad -astrometric solution. All rows have Gaia solution id -1635378410781933568.2100000source_idUnique source identifiermeta.id;meta.mainlongindexedprimaryraBarycentric Right Ascension in ICRS at ref_epochdegpos.eq.ra;meta.maindoubleindexednullabledecBarycentric Declination in ICRS at ref_epochdegpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied).masstat.error;pos.eq.rafloatnullabledec_errorStandard error of decmasstat.error;pos.eq.decfloatnullablelGalactic longitude (converted from ra, dec)degpos.galactic.londoublenullablebGalactic latitude (converted from ra, dec)degpos.galactic.latdoublenullablepmraProper motion in right ascension of the source in ICRS at ref_epoch. This is the projection of the proper motion vector in the direction of increasing right ascension.mas/yrpos.pm;pos.eq.radoublenullablepmdecProper motion in declination at ref_epoch.mas/yrpos.pm;pos.eq.decdoublenullablepmra_errorStandard error of pmramas/yrstat.error;pos.pm;pos.eq.rafloatnullablepmdec_errorStandard error of pmdecmas/yrstat.error;pos.pm;pos.eq.decfloatnullableparallaxAbsolute barycentric stellar parallax of the source at the reference epoch ref_epochmaspos.parallaxfloatnullableparallax_errorStandard error of parallaxmasstat.error;pos.parallaxfloatnullablephot_g_mean_magMean magnitude in the G band. This is computed from the G-band mean flux applying the magnitude zero-point in the Vega scale.magphot.mag;em.opt;stat.meanfloatnullablephot_g_mean_fluxG-band mean flux as electrons per second.s**-1phot.flux;em.opt;stat.meandoublenullablephot_g_mean_flux_errorError on phot_g_mean_fluxs**-1stat.error;phot.flux;em.opt;stat.meanfloatnullablephot_g_n_obsNumber of observations contributing to G photometrymeta.numbershortnullablephot_variable_flagPhotometric variability flagmeta.code;src.varcharnullableref_epochReference epoch to which the astrometic source parameters are referred, expressed as a Julian Year in TCB.yrmeta.ref;time.epochdoublenullableastrometric_delta_qHipparcos/Gaia data discrepancy (Hipparcos subset of TGAS only)stat.valuefloatnullableastrometric_excess_noiseExcess noise of the sourcemasstat.valuefloatnullableastrometric_excess_noise_sigSignificance of excess noisestat.valuefloatnullableastrometric_n_obs_acTotal number of observations ACmeta.numbershortastrometric_n_obs_alTotal number of observations ALmeta.numbershortastrometric_n_bad_obs_acNumber of bad observations ACmeta.numbershortastrometric_n_bad_obs_alNumber of bad observations ALmeta.numbershortastrometric_n_good_obs_acNumber of good observations ACmeta.numbershortastrometric_n_good_obs_alNumber of good observations ALmeta.numbershortastrometric_primary_flagOnly primary sources (for which this flag is True) contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is not affected by primariness.meta.codeshortmatched_observationsThe number of observations (detection transits) that have been matched to a given source during the last internal crossmatch revision.meta.numbershortastrometric_priors_usedType of prior used in in the astrometric solutionshortnullableastrometric_relegation_factorRelegation factor of the source calculated as per Eq. (118) in 2012A&A...538A..78L used for the primary selection process.arith.factorfloatnullableastrometric_weight_acMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableastrometric_weight_alMean astrometric weight of the sourcemas**-2stat.weight;stat.meanfloatnullableduplicated_sourceDuring data processing, this source happened to been duplicated and one source only has been kept.shortra_dec_corrCorrelation between right ascension and declinationstat.correlationfloatnullablera_pmra_corrCorrelation between right ascension and proper motion in right ascensionstat.correlationfloatnullablera_pmdec_corrCorrelation between right ascension and proper motion in declinationstat.correlationfloatnullabledec_pmra_corrCorrelation between declination and proper motion in right ascensionstat.correlationfloatnullabledec_pmdec_corrCorrelation between declination and proper motion in declinationstat.correlationfloatnullablepmra_pmdec_corrCorrelation between proper motion in right ascension and proper motion in declinationstat.correlationfloatnullablera_parallax_corrCorrelation between right ascension and parallaxstat.correlationfloatnullabledec_parallax_corrCorrelation between declination and parallaxstat.correlationfloatnullableparallax_pmra_corrCorrelation between parallax and proper motion in right ascensionstat.correlationfloatnullableparallax_pmdec_corrCorrelation between parallax and proper motion in declinationstat.correlationfloatnullablescan_direction_mean_k1Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k1Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k2Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k2Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k3Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k3Degree of concentration of scan directions across the sourcefloatnullablescan_direction_mean_k4Mean position angle of scan directions across the sourcedegfloatnullablescan_direction_strength_k4Degree of concentration of scan directions across the sourcefloatnullablerandom_indexRandom index that can be used to deterministically select subsetsmeta.codelonghipHipparcos identifierintnullabletycho2_idTycho 2 identifiercharnullable
theossaTheoSSA - Theoretical Stellar Spectra AccessTheoSSA provides spectral energy distributions based on model -atmosphere calculations. Currently, we serve results obtained using -the Tübingen NLTE Model Atmosphere Package (TMAP) for hot compact -stars.theossa.dataTheoSSA metadata in the SSAP schema.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharindexedssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoublenullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablet_effEffective temperature assumedKphys.temperature.effectivefloatnullablelog_gLog of surface gravity assumedcm/s**2phys.gravityfloatnullablemdotMass loss ratesolMass/yrphys.mass.lossfloatnullablew_hMass fraction of H in the model computed.phys.abundfloatnullablew_heMass fraction of He in the model computed.phys.abundfloatnullablew_liMass fraction of Li in the model computed.phys.abundfloatnullablew_beMass fraction of Be in the model computed.phys.abundfloatnullablew_bMass fraction of B in the model computed.phys.abundfloatnullablew_cMass fraction of C in the model computed.phys.abundfloatnullablew_nMass fraction of N in the model computed.phys.abundfloatnullablew_oMass fraction of O in the model computed.phys.abundfloatnullablew_fMass fraction of F in the model computed.phys.abundfloatnullablew_neMass fraction of Ne in the model computed.phys.abundfloatnullablew_naMass fraction of Na in the model computed.phys.abundfloatnullablew_mgMass fraction of Mg in the model computed.phys.abundfloatnullablew_alMass fraction of Al in the model computed.phys.abundfloatnullablew_siMass fraction of Si in the model computed.phys.abundfloatnullablew_pMass fraction of P in the model computed.phys.abundfloatnullablew_sMass fraction of S in the model computed.phys.abundfloatnullablew_clMass fraction of Cl in the model computed.phys.abundfloatnullablew_arMass fraction of Ar in the model computed.phys.abundfloatnullablew_kMass fraction of K in the model computed.phys.abundfloatnullablew_caMass fraction of Ca in the model computed.phys.abundfloatnullablew_scMass fraction of Sc in the model computed.phys.abundfloatnullablew_tiMass fraction of Ti in the model computed.phys.abundfloatnullablew_vMass fraction of V in the model computed.phys.abundfloatnullablew_crMass fraction of Cr in the model computed.phys.abundfloatnullablew_mnMass fraction of Mn in the model computed.phys.abundfloatnullablew_feMass fraction of Fe in the model computed.phys.abundfloatnullablew_coMass fraction of Co in the model computed.phys.abundfloatnullablew_niMass fraction of Ni in the model computed.phys.abundfloatnullablew_znMass fraction of Zn in the model computed.phys.abundfloatnullablew_gaMass fraction of Ga in the model computed.phys.abundfloatnullablew_geMass fraction of Ge in the model computed.phys.abundfloatnullablew_krMass fraction of Kr in the model computed.phys.abundfloatnullablew_moMass fraction of Mo in the model computed.phys.abundfloatnullablew_tcMass fraction of Tc in the model computed.phys.abundfloatnullablew_snMass fraction of Sn in the model computed.phys.abundfloatnullablew_xeMass fraction of Xe in the model computed.phys.abundfloatnullablew_baMass fraction of Ba in the model computed.phys.abundfloatnullable
tossTOSS -- Tübingen Oscillator Strengths Service This service provides oscillator strengths and transition -probabilities. Mainly based on experimental energy levels, these were -calculated with the pseudo-relativistic Hartree-Fock method including -core-polarization corrections.toss.dataA table of transitions, their species, and their properties.930656wavelengthWavelength of the transition.mem.wlssldm:Line.wavelength.valuedoubleindexedlinenameTerse descriptor of the linemeta.id;em.linessldm:Line.titlecharchemical_elementElement transitioningphys.atmol.elementssldm:Line.species.namecharindexednullableinitial_nameName of the level the atom or molecule starts in.phys.atmol.initial;phys.atmol.levelssldm:Line.initialLevel.namecharnullablefinal_nameName of the level the atom or molecule ends up in.phys.atmol.final;phys.atmol.levelssldm:Line.finalLevel.namecharnullableinitial_level_energyEnergy of the level the atom or molecule starts in.Jphys.energy;phys.atmol.initial;phys.atmol.leveldoublenullablefinal_level_energyEnergy of the level the atom or molecule ends up in.Jphys.energy;phys.atmol.final;phys.atmol.leveldoublenullablepubThe publication this value originated from.meta.bibcharnullableid_statusIdentification status of the linemeta.codecharnullableion_stageIonisation stagephys.atmol.ionStagecharindexednullablec_wavelengthConventional wavelength of the transition. This is the air wavelength between 2000 and 20000 Angstrom, the vacuum wavelength otherwise.Angstromem.wl;phys.atmol.transitiondoubleindexednullablepar_initParity of the init level of the transitionphys.atmol.paritycharj_initAngular momentum quantum number of the init level of the transition.phys.atmol.qnfloatnullablepar_finalParity of the final level of the transitionphys.atmol.paritycharj_finalAngular momentum quantum number of the final level of the transition.phys.atmol.qnfloatnullablelog_gfCalculated HRF log(gf) (g -- statistical weight of the lower level; f -- oscillator strength)phys.atmol.wOscStrengthfloatnullablegaTransition probability times the statistical weight of the upper level1e9s**-1phys.atmol.transProbfloatnullablecfCancellation factor as defined by 1981tass.book.....Cfloatnullable
toss.line_tap This is a prototype for a future LineTAP specification. If you are -not interested in validating LineTAP, you should probably not use this -table.ivo://ivoa.net/std/linetap#table-1.0titleHuman-readable line designation.meta.idcharindexedvacuum_wavelengthVacuum wavelength of the transitionAngstromem.wldoubleindexedvacuum_wavelength_errorTotal error in vacuum_wavelengthAngstromstat.error;em.wldoublenullablemethodMethod the wavelength was obtained with (XSAMS controlled vocabulary)meta.code.classcharnullableelementElement name for atomic transitions, NULL otherwise.phys.atmol.elementcharindexednullableion_chargeTotal charge (ionisation level) of the emitting particle.phys.electChargeintindexedmass_numberNumber of nucleons in the atom or moleculephys.atmol.weightintnullableupper_energyEnergy of the upper stateJphys.energy;phys.atmol.initialdoublenullablelower_energyEnergy of the lower stateJphys.energy;phys.atmol.finaldoublenullableinchiInternational Chemical Identifier InChI.meta.id;phys.atmol;meta.maincharinchikeyThe InChi key (hash) generated from inchi.meta.id;phys.atmolchareinstein_aEinstein A coefficient of the radiative transition.phys.atmol.transProbdoublenullablexsams_uriA URI for a full XSAMS description of this line.meta.refcharnullableline_referenceReference to the source of the line data; this could be a bibcode, a DOI, or a plain URI.meta.refcharnullable
twomassThe 2MASS point source catalogThe 2MASS Point Source Catalogue, short a couple of exotic fields. We -provide this data mainly for matching with other catalogs within our -TAP service.twomass.dataThe 2MASS Point Source Catalogue, short a couple of exotic fields. We -provide this data mainly for matching with other catalogs within our -TAP service.480000000raj2000Right ascension (J2000)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination (J2000)degpos.eq.dec;meta.maindoubleindexednullableerrmajMajor axis of position error ellipsedegstat.error;pos.eqfloatnullableerrminMinor axis of position error ellipsedegstat.error;pos.eqfloatnullableerrpaPosition angle of error ellipse major axis (E of N)degstat.error;pos.eqfloatnullablemainidSource designationmeta.id;meta.maincharindexedprimaryjmag2MASS J magnitudemagphot.mag;em.IR.JfloatindexednullablejcmsigJ default magnitude uncertaintymagstat.error;phot.mag;em.IR.Jfloatnullablee_jmag2MASS J total magnitude uncertaintymagstat.error;phot.mag;em.IR.JfloatnullablejsnrJ Signal-to-noise ratiostat.snr;phot.mag;em.IR.Jfloatnullablehmag2MASS H magnitudemagphot.mag;em.IR.HfloatindexednullablehcmsigH default magnitude uncertaintymagstat.error;phot.mag;em.IR.Hfloatnullablee_hmag2MASS H total magnitude uncertaintymagstat.error;phot.mag;em.IR.HfloatnullablehsnrH Signal-to-noise ratiostat.snr;phot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitudemagphot.mag;em.IR.Kfloatindexednullablekcmsigmagnitude uncertaintymagstat.error;phot.mag;em.IR.Kfloatnullablee_kmag2MASS K_s total magnitude uncertaintymagstat.error;phot.mag;em.IR.KfloatnullableksnrK Signal-to-noise ratiostat.snr;phot.mag;em.IR.KfloatnullableqflgJHK photometric quality flagmeta.code.qual;photcharnullablerflgJHK default magnitude read flagmeta.refcharnullablebflgJHK blend flagmeta.codecharnullablecflgContamination and confusion flagmeta.codecharnullablexflgExtended source contaminationmeta.codecharnullableaflgAssociation with asteroid or cometmeta.codecharnullablepts_keyUnique source identifier in cataloguemeta.id;meta.tablelongindexed"date"Observation dateyrtime.epoch;obscharnullablescanScan number (within date)meta.id;obs.fieldshortxscanDistance of source from focal plane centerlinedegpos.distance;pos.cartesian;instr.detfloatnullablejdJulian date of detectiondtime.epochcharnullableedgensDistance from the source to the nearest North or South scan edgedegpos;arith.difffloatnullableedgeewDistance from the source to the nearest East or West scan edgedegpos;arith.difffloatnullableedgeflag indicating to which edges the edgeNS and edgeEW values refermeta.code;pos.cartesian;instr.detcharnullabledupFlag indicating duplicate sourcemeta.codecharnullableuse_srcUse source flagmeta.codecharnullable
ucac3UCAC3 nocrossThe Third US Naval Observatory CCD Astrograph catalogue (UCAC3) is an -all-sky catalgoue containing just over 100 million objects covering -about R = 8-16 mag. This table contains the original data content of -UCAC3 but leaves out the data objetained by crossmatching to other -catalogs.ucac3.icrscorrCorrections between UCAC3 and the ICRS as represented by PPMXL on a -grid of degrees, obtained by substracting UCAC3 from PPMXL in cones of -radius sqrt(2)/2 degrees around the given center position.65294nobNumber of objects the correction is based onmeta.numberintalphaCenter for field, RAdegpos.eq.ra;meta.mainfloatindexednullabledeltaCenter for field, Decdegpos.eq.dec;meta.mainfloatindexednullabled_alphaCorrection PPMXL-UCAC3 in alpha (Epoch 2000.0)degpos.eq.ra;arith.difffloatnullabled_deltaCorrection PPMXL-UCAC3 in delta (Epoch 2000.0)degpos.eq.dec;arith.difffloatnullabled_pmalphaCorrection PPMXL-UCAC3 in proper motion alpha*cos(delta)deg/yrpos.pm;pos.eq.ra;arith.difffloatnullabled_pmdeltaCorrection PPMXL-UCAC3 in deltadeg/yrpos.pm;pos.eq.dec;arith.difffloatnullable
ucac3.mainThe UCAC3 all-sky CCD astrograph catalogue, minus the fields from -2MASS and SuperCosmos and matching/object flags (which can be -recovered with a local crossmatch).110000000raj2000Right ascension at epoch (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at epoch (ICRS)degpos.eq.dec;meta.maindoubleindexednullablemmagUCAC fit model magnitudemagphot.mag;em.optfloatnullablemaperUCAC aperture magnitudemagphot.mag;em.optfloatnullablesigmagUCAC error on magnitude (larger of obs. scatter and model error)magstat.error;phot.mag;em.optfloatnullableobjtObject typesrc.classcharnullabledsfDouble star flagmeta.codecharnullablesigras.e. at central epoch in RA (*cos Dec)degstat.error;pos.eq.rafloatnullablesigdcs.e. at central epoch in Decdegstat.error;pos.eq.decfloatnullablena1Total number of CCD images of this starmeta.numbershortnu1Number of CCD images used for this starmeta.number;stat.fitshortus1Number of catalogs/epochs used for proper motionsmeta.numbershortcn1Number of catalogs/epochs in initial matchmeta.numbershortcepraCentral epoch for mean RAtime.epochcharnullablecepdcCentral epoch for mean Declinationtime.epochcharnullablepmraProper motion in RA, cos(Dec) applieddeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Declinationdeg/yrpos.pm;pos.eq.decfloatnullablesigpmraError in proper motion in RA, cos(Dec) applieddeg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdeError in proper motion in Declinationdeg/yrstat.error;pos.pm;pos.eq.decfloatnullable
ucac3.ppmxlcrossA crossmatch between UCAC3 and PPMXL, created solely based on -positions with a window of 1.5 arcsec radius.99000000ucac3idipix of UCAC3 objectmeta.idlongindexedppmxlidPPMXL ipixmeta.id;meta.mainlongindexed
ucac4The fourth U.S. Naval Observatory CCD Astrograph Catalog (UCAC4) UCAC4 is a compiled, all-sky star catalog covering mainly the 8 to 16 -magnitude range in a single bandpass between V and R. -Positional errors are about 15 to 20 mas for stars in the 10 to 14 mag -range. Proper motions have been derived for most of the about 113 -million stars utilizing about 140 other star catalogs with significant -epoch difference to the UCAC CCD observations. These data are -supplemented by 2MASS photometric data for about 110 million stars and -5-band (B,V,g,r,i) photometry from the APASS (AAVSO Photometric -All-Sky Survey) for over 50 million stars. UCAC4 also contains error -estimates and various flags. All bright stars not observed with -the astrograph have been added to UCAC4 from a set of Hipparcos and -Tycho-2 stars. Thus UCAC4 should be complete from the brightest stars -to about R=16, with the source of data indicated in flags.ucac4.main UCAC4 is a compiled, all-sky star catalog covering mainly the 8 to 16 -magnitude range in a single bandpass between V and R. -Positional errors are about 15 to 20 mas for stars in the 10 to 14 mag -range. Proper motions have been derived for most of the about 113 -million stars utilizing about 140 other star catalogs with significant -epoch difference to the UCAC CCD observations. These data are -supplemented by 2MASS photometric data for about 110 million stars and -5-band (B,V,g,r,i) photometry from the APASS (AAVSO Photometric -All-Sky Survey) for over 50 million stars. UCAC4 also contains error -estimates and various flags. All bright stars not observed with -the astrograph have been added to UCAC4 from a set of Hipparcos and -Tycho-2 stars. Thus UCAC4 should be complete from the brightest stars -to about R=16, with the source of data indicated in flags.120000000ucacidUCAC 2 identification number (UCAC4-zzz-nnnnnn)meta.id;meta.maincharindexednullableraj2000Right Ascension at epoch J2000.0 (ICRS)degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at epoch J2000.0 (ICRS)degpos.eq.dec;meta.maindoubleindexednullablemagmUCAC fit model magnitudemagphot.mag;em.opt.VfloatnullablemagaUCAC aperture magnitudemagphot.mag;em.opt.Vfloatindexednullablesigmagerror of UCAC magnitudemagstat.error;phot.mag;em.opt.VfloatnullableobjtObject typesrc.classshortcdfCombined double star flagmeta.code.multipshortsigraStandard error at central epoch in RA (*cos Dec)degstat.error;pos.eq.rafloatnullablesigdecStandard error at central epoch in Decdegstat.error;pos.eq.decfloatnullablena1Total number of CCD images of this starmeta.numbershortnu1Number of CCD images used for this starmeta.numbershortcu1Number of catalogs (epochs) used for proper motionsmeta.numbershortcepraCentral epoch for mean RAyrtime.epochfloatnullablecepdecCentral epoch for mean Decyrtime.epochfloatnullablepmraProper motion in RA*cos(Dec)deg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in Decdeg/yrpos.pm;pos.eq.decfloatnullablesigpmrStandard error of proper motion in RA*cos(Dec)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdStandard error of proper motion in Decdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablepts_key2MASS unique star identifiermeta.idintnullablemagj2MASS J magnitudemagphot.mag;em.IR.JfloatnullablesigmagjError in 2MASS J magnitudemagstat.error;phot.mag;em.IR.JfloatnullableicqflgjQuality flag for 2MASS J magnitudemagmeta.code;phot.mag;em.IR.Jshortnullablemagh2MASS H magnitudemagphot.mag;em.IR.HfloatnullablesigmaghError in 2MASS H magnitudemagstat.error;phot.mag;em.IR.HfloatnullableicqflghQuality flag for 2MASS H magnitudemagmeta.code;phot.mag;em.IR.Hshortnullablemagk_s2MASS K_s magnitudemagphot.mag;em.IR.Kfloatnullablesigmagk_sError in 2MASS K_s magnitudemagstat.error;phot.mag;em.IR.Kfloatnullableicqflgk_sQuality flag for 2MASS K_s magnitudemagmeta.code;phot.mag;em.IR.KshortnullablemagbB magnitude from APASSmagphot.mag;em.opt.BfloatnullablesigmagbError in B magnitude from APASSmagstat.error;phot.mag;em.opt.BfloatnullablemagvV magnitude from APASSmagphot.mag;em.opt.VfloatnullablesigmagvError in V magnitude from APASSmagstat.error;phot.mag;em.opt.Vfloatnullablemaggg magnitude from APASSmagphot.mag;em.opt.VfloatnullablesigmaggError in g magnitude from APASSmagstat.error;phot.mag;em.opt.Vfloatnullablemagrr magnitude from APASSmagphot.mag;em.opt.RfloatnullablesigmagrError in r magnitude from APASSmagstat.error;phot.mag;em.opt.Rfloatnullablemagii magnitude from APASSmagphot.mag;em.opt.IfloatnullablesigmagiError in i magnitude from APASSmagstat.error;phot.mag;em.opt.IfloatnullablespmflagsYale SPM g and c flagsmeta.code;srcshortnullablesrcflagsSource flags (see note)meta.codeintnullablediam2massObject size from 2MASSdegphys.angSize;srcfloatnullablernmUnique star identification numbermeta.idintzn2Zone number of UCAC2meta.id.partshortnullablern2Running record number along UCAC2 zonemeta.idintnullable
ucac5The fifth U.S. Naval Observatory CCD Astrograph Catalog (UCAC5) New astrometric reductions of the US Naval Observatory CCD Astrograph -Catalog (UCAC) all-sky observations were performed from first -principles using the TGAS stars in the 8 to 11 magnitude range as -reference star catalog. Significant improvements in the astrometric -solutions were obtained and the UCAC5 catalog of mean positions at a -mean epoch near 2001 was generated. By combining UCAC5 with Gaia DR1 -data new proper motions on the Gaia coordinate system for over 107 -million stars were obtained with typical accuracies of 1 to 2 mas/yr -(R = 11 to 15 mag), and about 5 mas/yr at 16th mag. Proper motions of -most TGAS stars are improved over their Gaia data and the precision -level of TGAS proper motions is extended to many millions more, -fainter stars. - -The database table uses actual NULLs for missing photometry, and all -angular coordinates have been homogenised to degrees.ucac5.main New astrometric reductions of the US Naval Observatory CCD Astrograph -Catalog (UCAC) all-sky observations were performed from first -principles using the TGAS stars in the 8 to 11 magnitude range as -reference star catalog. Significant improvements in the astrometric -solutions were obtained and the UCAC5 catalog of mean positions at a -mean epoch near 2001 was generated. By combining UCAC5 with Gaia DR1 -data new proper motions on the Gaia coordinate system for over 107 -million stars were obtained with typical accuracies of 1 to 2 mas/yr -(R = 11 to 15 mag), and about 5 mas/yr at 16th mag. Proper motions of -most TGAS stars are improved over their Gaia data and the precision -level of TGAS proper motions is extended to many millions more, -fainter stars. - -The database table uses actual NULLs for missing photometry, and all -angular coordinates have been homogenised to degrees.110000000source_idGaia source IDmeta.id;meta.mainlongraGaia DR1 Right Ascension at epoch J2015.0degpos.eq.ra;meta.maindoubleindexednullabledecGaia DR1 Declination at epoch J2015.0degpos.eq.dec;meta.maindoubleindexednullablera_errorStandard error of ra (with cos δ applied); from Gaia DR1.degstat.error;pos.eq.rafloatnullabledec_errorStandard error of dec; from Gaia DR1.degstat.error;pos.eq.decfloatnullablesrcflagsSource for the star: 1 = TGAS, 2 = other UCAC-Gaia star, 3 = other NOMADmeta.codeshortnu1Number of images used for UCAC mean positionmeta.numbershortepuMean UCAC epoch (i.e. epoch for ra_ucac and de_ucac)yrtime.epochfloatnullablera_ucacMean UCAC RA at epoch epu on Gaia reference framedegpos.eq.radoublenullablede_ucacmean UCAC Dec at epoch epu on Gaia reference framedegpos.eq.decdoublenullablepmraPM(RA), cos(δ) applied, computed from UCAC and Gaia DR1 positions.deg/yrpos.pm;pos.eq.rafloatnullablepmdePM(Dec), computed from UCAC positions and Gaia DR1 positions.deg/yrpos.pm;pos.eq.decfloatnullablesigpmrStandard error of proper motion in RA*cos(Dec)deg/yrstat.error;pos.pm;pos.eq.rafloatnullablesigpmdStandard error of proper motion in Decdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablegmagGaia DR1 G magnitudemagphot.mag;em.optfloatnullableumagMean UCAC model magnitude (20 in the source is mapped to NULL)magphot.mag;em.opt.VfloatnullablermagNOMAD photographic R mag (0 and 30 in the source are mapped to NULL)magphot.mag;em.opt.Rfloatnullablejmag2MASS J magnitude (0 and 30 in the source are mapped to NULL)magphot.mag;em.IR.Jfloatnullablehmag2MASS H magnitude (0 and 30 in the source are mapped to NULL)magphot.mag;em.IR.Hfloatnullablekmag2MASS K_s magnitude (0 and 30 in the source are mapped to NULL)magphot.mag;em.IR.Kfloatnullable
urat1The first U.S. Naval Observatory Astrometric Robotic Telescope Catalog -URAT1 star catalog -URAT1 is an observational catalog at a mean epoch between 2012.3 and -2014.6; ot covers the magnitude range 3 to 18.5 in R-band, with a -positional precision of 5 to 40 mas. It covers most of the northern -hemisphere and some areas down to -24.8° in declination. - -In the GAVO data center, we left out all columns originating from -cross matches with other catalogs; on-the fly crossmatches can be done -in our TAP service.urat1.main -URAT1 is an observational catalog at a mean epoch between 2012.3 and -2014.6; ot covers the magnitude range 3 to 18.5 in R-band, with a -positional precision of 5 to 40 mas. It covers most of the northern -hemisphere and some areas down to -24.8° in declination. - -In the GAVO data center, we left out all columns originating from -cross matches with other catalogs; on-the fly crossmatches can be done -in our TAP service.230000000idURAT1 recommended identifier (ZZZ-NNNNNN)meta.id;meta.maincharindexedprimaryraj2000Right ascension on ICRS, at Epochdegpos.eq.ra;meta.maindoubleindexednullabledej2000Declination on ICRS, at Epochdegpos.eq.dec;meta.maindoubleindexednullablepos_err_scatterPosition error per coordinate, from scatterdegstat.error;posfloatnullablepos_err_modelPosition error per coordinate, from modeldegstat.error;posfloatnullableepochMean URAT observation epochyrtime.epochfloatnullablemagMean URAT model fit magnitude (between R and I)magphot.mag;em.opt.Rfloatindexednullablee_magError in URAT model fit magnitude, derived from the scatter of individual observations, plus a floor of 0.01.magstat.error;phot.mag;em.opt.Rfloatnullablen_setsTotal number of images (observations)meta.number;obsshortn_sets_posNumber of sets used for mean positionmeta.number;obsshortn_sets_magNumber of sets used for URAT magnitudemeta.number;obsshortrefstarLargest reference star flagmeta.code.qualcharn_imTotal number of images (observations)meta.number;obsshortn_im_usedNumber of images used for mean positionmeta.number;obsshortn_gratingTotal number of 1st order grating observationsmeta.number;obsshortn_grating_usedNumber of 1st order grating positions usedmeta.number;obsshort
usnobThe USNO-B 1.0 CatalogThe USNO-B catalog is an all-sky catalog of about 1e9 objects -including their proper motions, based on scans of several sky surveys -conducted between 1950 and the late 1990ies.usnob.dataThe USNO-B 1.0 catalogue with Barron's spurious detections removed.1100000000raj2000Right Ascension at Eq=J2000, Ep=J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination at Eq=J2000, Ep=J2000degpos.eq.dec;meta.maindoubleindexednullablee_radegMean error on RAdeg*cos(DEdeg) at Epochdegstat.error;pos.eq.rafloatnullablee_dedegMean error on DEdeg at Epochdegstat.error;pos.eq.decfloatnullableepochMean epoch of observationyrtime.epochfloatnullablepmraProper motion in RAdeg/yrpos.pm;pos.eq.rafloatnullablepmdeProper motion in DEdeg/yrpos.pm;pos.eq.decfloatnullablemuprTotal Proper Motion probabilitystat.fit.goodnessfloatnullablee_pmraMean error on pmRAdeg/yrstat.error;pos.pm;pos.eq.rafloatnullablee_pmdeMean error on pmDEdeg/yrstat.error;pos.pm;pos.eq.decfloatnullablefit_raMean error on RA fitdegstat.errorfloatnullablefit_deMean error on DE fitdegstat.errorfloatnullablendetNumber of detectionsmeta.numbershortflagsFlags on objectmeta.codecharnullableb1magFirst blue magnitude (B1)magphot.mag;em.opt.Bfloatnullableb1sB1 Survey codemeta.idcharindexednullableb1fB1 Field number in surveymeta.id;obs.fieldshortindexednullableb1sgB1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb1xiB1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb1etaB1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler1magFirst red magnitude (R1)magphot.mag;em.opt.Rfloatnullabler1sR1 Survey codemeta.idcharindexednullabler1fR1 Field number in surveymeta.id;obs.fieldshortindexednullabler1sgR1 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler1xiR1 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler1etaR1 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableb2magSecond blue magnitude (B2)magphot.mag;em.opt.Bfloatnullableb2sB2 Survey codemeta.idcharindexednullableb2fB2 Field number in surveymeta.id;obs.fieldshortindexednullableb2sgB2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableb2xiB2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableb2etaB2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullabler2magSecond red magnitude (R2)magphot.mag;em.opt.Rfloatnullabler2sR2 Survey codemeta.idcharindexednullabler2fR2 Field number in surveymeta.id;obs.fieldshortindexednullabler2sgR2 Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullabler2xiR2 Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullabler2etaR2 Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullableimagInfrared (N) magnitudemagphot.mag;em.opt.Ifloatnullablei_sI Survey codemeta.idcharindexednullableifI Field number in surveymeta.id;obs.fieldshortindexednullableisgI Star/galaxy separation, A=Galaxy, L=Starsrc.class.starGalaxycharnullableixiI Residual in X directiondegstat.fit.residual;pos.cartesian.xfloatnullableietaI Residual in Y directiondegstat.fit.residual;pos.eq.dec;arith.difffloatnullable
usnob.platecorrsICRS Corrections by USNO-B1 PlatePlate corrections to USNO-B 1.0 based on a crossmatch with PPMX7194surveySurvey identifier, see long docsmeta.idcharfieldField number in surveymeta.id;obs.fieldshortdaMean offset in alphadegpos.eq.ra;arith.difffloatnullableddMean offset in deltadegpos.eq.dec;arith.difffloatnullablentotalNumber of objects in estimatemeta.numberint
usnob.platesPlate data for the source plates of USNO-B8855fieldField number in surveymeta.id;obs.fieldshortplatePlate number in USNO-Bmeta.id;obs.field;meta.maincharnullablesurveySurvey identifier, see long docsmeta.idcharindexedepochPlate epochyrtime.epochcharnullableemulsionEmulsioninstr.plate.emulsioncharnullablefilterFiltermeta.id;instr.filtercharnullableexposureLength of exposurestime.duration;obs.exposurefloatnullableusnocode2-char plate code given in the plate cataloguemeta.id;obs.fieldcharnullablealpha1950Field center alpha for B1950degpos.eq.rafloatnullabledelta1950Field center decl for B1950degpos.eq.decfloatnullablealpha2000Field center alpha for J2000degpos.eq.ra;meta.mainfloatindexednullabledelta2000Field center decl for J2000degpos.eq.dec;meta.mainfloatindexednullablesrcSource file for this recordmeta.ref;meta.filecharnullablealphamin1950degpos.eq.ra;stat.minfloatnullablealphamax1950degpos.eq.ra;stat.maxfloatnullabledeltamin1950degpos.eq.dec;stat.minfloatnullabledeltamax1950degpos.eq.dec;stat.maxfloatnullable
usnob.ppmxcrossA crossmatch between USNO-B 1.0 and PPMX.18000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedppmxidPPMX id of matching objectmeta.id;meta.maincharindexednullable
usnob.spuriousSpurious detections in USNO-B 1.0 as established by Barron et al, -2008AJ....135..414B.18000000raRA of spurious detectiondegpos.eq.ra;meta.maindoubleindexednullabledecDec of spurious detectiondegpos.eq.dec;meta.maindoubleindexednullable
usnob.twomasscrossA crossmatch between USNO-B 1.0 and 2MASS.360000000ipixq3c ipix value of USNO-B objectmeta.idlongindexedtwomassid2MASS id of matching objectmeta.id;meta.maincharindexednullable
veronqsosQuasars and Active Galactic Nuclei (8th Ed.) This catalogue (with updates to the pervious version) contains 11358 -(+2759) quasars (defined as brighter than absolute B magnitude -23), -3334 (+501) AGNs (defined as fainter than absolute B magnitude -23) -and 357 (+137) BL Lac objects from 1863 (+201) references.veronqsos.data This catalogue (with updates to the pervious version) contains 11358 -(+2759) quasars (defined as brighter than absolute B magnitude -23), -3334 (+501) AGNs (defined as fainter than absolute B magnitude -23) -and 357 (+137) BL Lac objects from 1863 (+201) references.11358notradio'*' if not detected in radiometa.notecharnullablenameMost common name of the objectmeta.idcharnullableraj2000Right Ascension J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination J2000degpos.eq.dec;meta.maindoubleindexednullablen_rahPosition origin: O=optical, R=radio, A=approximativemeta.notecharnullablel_z*=redshift from slitless spectroscopymeta.code.errorcharnullablezRedshiftsrc.redshiftfloatnullablespSpectrum classificationsrc.spTypecharnullablen_vmag'*' for photographic, 'R' for red Vmagmeta.notecharnullablevmagmagnitude, V or other (see n_Vmag)magphot.mag;em.opt.Vfloatnullabler_zReference of the redshiftmeta.refshortnullable
vlastripe82High-Resolution Very Large Array Imaging of Sloan Digital Sky Survey -Stripe 82 at 1.4 GHz -This is a high-resolution radio survey of the Sloan Digital Sky Survey -(SDSS) Southern Equatorial Stripe, a.k.a. Stripe 82. This 1.4 GHz survey -was conducted with the Very Large Array (VLA) primarily in the -A-configuration, with supplemental B-configuration data to increase -sensitivity to extended structure. The survey has an angular resolution -of 1.''8 and achieves a median rms noise of 52 μJy per beam over 92 deg^2. -The catalog contains 17,969 isolated radio components, for an overall -source density of ∼195 sources/deg^2. See also J.A. Hodge et al, -:bibcode:`2011AJ....142....3H` .vlastripe82.stripe82 -This is a high-resolution radio survey of the Sloan Digital Sky Survey -(SDSS) Southern Equatorial Stripe, a.k.a. Stripe 82. This 1.4 GHz survey -was conducted with the Very Large Array (VLA) primarily in the -A-configuration, with supplemental B-configuration data to increase -sensitivity to extended structure. The survey has an angular resolution -of 1.''8 and achieves a median rms noise of 52 μJy per beam over 92 deg^2. -The catalog contains 17,969 isolated radio components, for an overall -source density of ∼195 sources/deg^2. See also J.A. Hodge et al, -:bibcode:`2011AJ....142....3H` .17969raj2000Right Ascension, J2000degpos.eq.ra;meta.maindoubleindexednullabledej2000Declination, J2000degpos.eq.dec;meta.maindoubleindexednullablep_sProbability that the source is spurious (e.g., because of a sidelobe of a nearby bright source).stat.likelihood;obsfloatnullablef_peakPeak flux density derived by fitting an elliptical Gaussian model to the source. The uncertainty is given in the rms_nose column.mJy/beamphot.flux.density;em.radio.1500-3000MHz;stat.maxfloatindexednullablef_intIntegrated flux density in mJy derived from the elliptical Gaussian model fit.mJyphot.flux.density;em.radio.1500-3000MHzfloatnullablerms_noiseLocal noise estimate at the source position, calculated by combining the measured noise from all grid images contributing to the coadded map at the source position.mJystat.error;phot.flux.densityfloatnullablesmaj_axFWHM semimajor axis of the elliptical Gaussian model for the source after beam deconvolution. This is zero when the fitted value prior to deconvolution to is smaller than the beam (1.8'') due to noise.degphys.angSize.smajAxis;meta.modelledfloatnullablesmin_axFWHM semiminor axis of the elliptical Gaussian model for the source after beam deconvolution. This is zero when the fitted value prior to deconvolution to is smaller than the beam due to noise.degphys.angSize.sminAxis;meta.modelledfloatnullablepaPosition angle of the elliptical Gaussian model for the source after beam deconvolution, east of north.degpos.posAng;meta.modelledfloatnullablesmaj_ax_rawFWHM semimajor axis of the elliptical Gaussian model before beam deconvolution.degphys.angSize.smajAxisfloatnullablesmin_ax_rawFWHM semiminor axis of the elliptical Gaussian model before beam deconvolution.degphys.angSize.sminAxisfloatnullablepa_rawPosition angle of the elliptical Gaussian model for the source before beam deconvolution, east of north.degpos.posAngfloatnullablefieldThe field name is the name of the coadded image containing the source. Note that the field name encodes the center of the field; field hhmmm+ddmmm is centered at RA = hh mm.m, Dec = +dd mm.m. The letter appended to the field name indicates the last catalog release in which the image was modified.meta.id;obs.fieldcharnullablen_sdssNumber of matching SDSS DR6 objects within 8 arcsec.meta.numberintd_sdssSeparation of the closest match in SDSS DR6.degpos.angDistancefloatnullableimagSDSS i-band magnitude of the closest match in SDSS DR6.magphot.mag;em.opt.Ifloatindexednullablec_sdssSDSS morphological class of the closest match in SDSS DR6; s = stellar, g = nonstellar/galaxy.src.morph.typecharnullablectRow count; this is not part of the original table but was added to satisfy SCS requirements.meta.id;meta.mainint
wdsdss10New white dwarf stars in the SDSS-DR10 The catalogue WDSLOAN10 has been constructed by spectroscopically -selecting white dwarfs and subdwarfs in the Sloan Digital Sky Survey -Data Release 10. It offers Teff, log(g) and mass for hydrogen -atmosphere white dwarf stars (DAs) and helium atmosphere white dwarf -stars (DBs), and estimatives of calcium/helium abundances for the -white dwarf stars with metallic lines (DZs) and carbon/helium for -carbon dominated spectra DQs.wdsdss10.main The catalogue WDSLOAN10 has been constructed by spectroscopically -selecting white dwarfs and subdwarfs in the Sloan Digital Sky Survey -Data Release 10. It offers Teff, log(g) and mass for hydrogen -atmosphere white dwarf stars (DAs) and helium atmosphere white dwarf -stars (DBs), and estimatives of calcium/helium abundances for the -white dwarf stars with metallic lines (DZs) and carbon/helium for -carbon dominated spectra DQs.9114raj2000Right ascensiondegpos.eq.ra;meta.maindoubleindexeddecj2000Declinationdegpos.eq.dec;meta.maindoubleindexedsnrg-band signal-to-noise ratiostat.snr;phot.flux;em.opt.BintuSDSS u band PSF magnitudemagphot.mag;em.opt.Ufloatu_errSDSS u band uncertaintymagstat.error;phot.mag;em.opt.UfloatgSDSS g band PSF magnitudemagphot.mag;em.opt.Bfloatg_errSDSS g band uncertaintymagstat.error;phot.mag;em.opt.BfloatrSDSS r band PSF magnitudemagphot.mag;em.opt.Rfloatr_errSDSS r band uncertaintymagstat.error;phot.mag;em.opt.RfloatiSDSS i band PSF magnitudemagphot.mag;em.opt.Ifloati_errSDSS i band uncertaintymagstat.error;phot.mag;em.opt.IfloatzSDSS z band PSF magnitudemagphot.mag;em.opt.Ifloatz_errSDSS z band uncertaintymagstat.error;phot.mag;em.opt.IfloatpmSDSS proper motionmas/yrpos.pmfloatt_effEffective TemperatureKphys.temperature.effective;meta.mainintt_errError effective temperatureKstat.error;phys.temperature.effective;meta.mainintlog_gSurface gravitylog(cm/s**2)phys.gravity;meta.mainfloatlog_gerrSurface gravity errorlog(cm/s**2)stat.error;phys.gravity;meta.mainfloathumanidHuman clssificationmeta.code.classchart_eff_3dTemperature (convective model) for pure DAs and DBsKphys.temperature;meta.modelledintnullablet_err_3dError temperature (convective model)Kstat.error;phys.temperature;meta.modelledintnullablelog_g_3dphys.gravity;meta.modelledfloatnullablelog_gerr_3dstat.error;phys.gravity;meta.modelledfloatnullablemassCalculated masssolMassphys.massfloatnullablemass_errMass uncertaintysolMassstat.error;phys.massfloatnullablelog_caCalcium/Helium emission lines ratiophys.abund;arith.ratiofloatnullablelog_ca_errCalcium/Helium emission lines ratio errorstat.error;phys.abund;arith.ratiofloatnullablelog_cCarbon/Helium emission lines ratiophys.abund;arith.ratiofloatnullablelog_c_errCarbon/Helium emission lines ratio errorstat.error;phys.abund;arith.ratiofloatnullablepdfSDSS object/observation identifiermeta.id;meta.maincharindexedprimary
wfpdbWide-Field Plate Database WFPDB -The Wide-Field Plate Database (WFPDB_) contains the descriptive information -for the astronomical wide-field (>1°) photographic observations stored in -numerous archives all over the world. The total number of these -observations, obtained since the end of the 19th century with more -then 200 instruments (telescopes) is about 2 550 000 from 509 archives. - -The WFPDB is continually being updated, providing currently access to the -information for about 640 000 plates from 117 plate archives (30% of the -estimated total number of wide-field plates) - -.. _WFPDB: http://www.skyarchive.org/wfpdb.archivesWFPDB Archives Table A table of plate archives included in the WFPDB or scheduled for -inclusion, as well as the properties of the instruments used to take -the data.509instr_idWFPDB-internal instrument designationmeta.id;instrcharnullablearchive_idWFPDB-internal archive designation, consisting of the instrument id, the archive code, and the site code.meta.id;meta.maincharindexedprimarywfpdb_statusInclusion status of plates from this archive: * - at disposal in SSADC, not yet converted in computer-readable form, ** - in preparation in SSADC, converted in computer readable form, *** - included in the WFPDB and available on-line.meta.codecharnullableinstr_nameOriginal name of the instrument as used by the relevant observatorymeta.id;instrcharnullablearchive_locationLocation of the plate archivemeta.id;instr.obstycharnullablearch_partCode for a sub-archive when an instrument's archive is split across several sitesintinst_nameName of the hosting institutioncharnullablesite_codeCode for the instrument site when the instrument was operated from several locations.meta.idcharsite_nameObservatory sitemeta.id;instr.obstycharnullablecountryCountry the observatory is located in.meta.id;pos.earthcharnullablempc_numberMinor Planet Center observatory codemeta.id;instr.obstyintnullabletime_zoneTime difference to Greenwichhtime;arith.difffloatnullablelongGeographical longitude of the observatory.degpos.earth.lonfloatnullablelatGeographical latitude of the observatory.degpos.earth.latfloatnullablealtitudeAltitude of the observatory.mpos.earth.altitudefloatnullablen_tubesNumber of telescope tubes.meta.number;instr.telcharnullableapertureClear aperture of the telescope.mphys.size;instr.telfloatnullablediameterDiameter of the primary mirror or the objective lensmfloatnullablefocal_lengthFocal length of the telescopeminstr.tel.focalLengthfloatnullableplate_scalePlate scalearcsec/mmfloatnullableinst_typeInstrument type: Ast-astrograph, Cam-camera, FEC-fish eye camera, Men-meniscus, RCr-Ritchey-Chretien, Rfl-reflector, Rfr- refractor, Sch-Schmidtcharnullableang_sizeMaximum angular size of the field of view.degphys.angsize;instr.fovfloatnullableop_beginYear telescope operations started.yrtime.epochfloatnullableop_endYear telescope operations ended.yrtime.epochfloatnullabledet_typeDetector used: blank--plate, F--film, X--film and platemeta.code;instrcharnullablen_directNumber of direct plates in the archive.meta.number;obsintnullablen_prismNumber of prism plates in the archive.meta.number;obsintnullablecontactName of the contact person.charnullable
wfpdb.mainWFPDB TAP-queriable Table WFPDB's table of plates, including position observed and the epoch of -observation.609884instr_idWFPDB instrument identifier. TDB: Foreign keymeta.id;instrcharindexednullablewfpdbidWFPDB identifier of the plate, consisting of an observatory identifier, the instrument aperture, an instrument suffix, a plate number, and a suffix to it.meta.id;meta.maincharindexedprimaryraj2000Right ascension of the plate center (ICRS)degpos.eq.ra;meta.mainfloatindexednullabledej2000Declination of the plate center (ICRS)degpos.eq.dec;meta.mainfloatindexednullablecoord_problemQuality flag for the coordinates (empty means no known problems)meta.notecharnullableepochEpoch of observation start (UT)yrtime.epochdoubleindexednullabletime_problemQuality flag for the epoch (empty means no known problems)meta.notecharnullableobjectObject or field name as given by observermeta.id;srcunicodeCharindexednullableobject_typeType of the target objectsrc.classcharindexednullablemethodMethod of observationinstr.setupcharnullableexptimeExposure time (for multiple exposures, this is for the first exposure; for the others, see notes)stime.duration;obs.exposurefloatnullableemulsionEmulsion typeinstr.plate.emulsioncharnullablefilterFilter typemeta.id;instr.filtercharnullablewavebandSpectral Bandinstr.bandpasscharindexednullablexsizeWidth of the platecmphys.size;instr.detfloatnullableysizeHeight of the platecmphys.size;instr.detfloatnullableobserverName(s) of the persons having performed the observation.obs.observerunicodeCharnullablenotesVarious longer remarksmeta.noteunicodeCharnullablequalityQuality-related information in free text.meta.noteunicodeCharnullableavailabilityFree text on how to find the plate.meta.notecharnullabledigitizationInformation on possible ways to access plate scans in free text.meta.noteunicodeCharnullablewfpdb.archivesinstr_idinstr_id
wiseWISE All-Sky Release Catalog -The Wide-field Infrared Survey Explorer (WISE) is a space-based imaging -survey of the entire sky in the 3.4 (W1), 4.6 (W2), 12 (W3), and 22 (W4) μm -mid-infrared. This is the project's reliable Source Catalog containing -accurate photometry and astrometry for over 500 million objects. - -More details are available in the `Explanatory Supplement`_, which also -has a list of `Cautionary Notes`_. - -.. _Explanatory Supplement: http://wise2.ipac.caltech.edu/docs/release/allsky/expsup/sec1_1.html -.. _Cautionary Notes: http://wise2.ipac.caltech.edu/docs/release/allsky/expsup/sec1_4b.htmlwise.main This is the All-Sky source catalog, with several columns left out -since we considered them to be only relevant for re-reduction, too -arcane, or just because of a whim on our side. If you need them, let -us know. The columns left out include: elon, elat, source_id, w?nm -w?m, w?cov, w?cc_map_str, w?flux, w?sigflux, w?sky, w?sigsk, w?conf, -w?mag_?, w?sigm_?, w?flg_?, w?magp, w?sigp1, w?sigp2, rho??, r_2mass, -pa_2mass, n_2mass, [jhk]_m_2mass, [jhk]_msig_2mass, best_use_cntr, -ngrp, x, y, z, spt_ind570000000designationSexagesimal, equatorial position-based source name in the form: hhmmss.ss+ddmmss.s. The full naming convention for WISE All-Sky Release Catalog sources has the form 'WISE Jhhmmss.ss+ddmmss.s,', where WISE is not given in this column.meta.id;meta.maincharindexedprimaryraj2000J2000 right ascension with respect to the 2MASS PSC reference framedegpos.eq.ra;meta.maindoubleindexednullabledej2000J2000 declination with respect to the 2MASS PSC reference frame.degpos.eq.dec;meta.maindoubleindexednullablesigraOne-sigma uncertainty in right ascension coordinate.degstat.error;pos.eq.rafloatnullablesigdecOne-sigma uncertainty in declination coordinate.degstat.error;pos.eq.decfloatnullablesigradecThe co-sigma of the equatorial position uncertainties, sig_ra, sig_dec (σα, σδ).degstat.error;pos.eqfloatnullableglonGalactic longitude. CAUTION: This coordinate should not be used as an astrometric reference.degpos.galactic.londoublenullableglatGalactic latitude. CAUTION: This coordinate should not be used as an astrometric reference.degpos.galactic.latdoublenullablewxThe x-pixel coordinate of this source on the Atlas Image.pixpos.cartesian.x;instr.detfloatnullablewyThe y-pixel coordinate of this source on the Atlas Image.pixpos.cartesian.y;instr.detfloatnullablecntrUnique identification number for the Catalog source.meta.idlongcoadd_idAtlas Tile identifier from which source was extracted.meta.idcharnullablesrcSequential number of this source extraction in the Atlas Tile from which this source was extracted, in approximate descending order of W1 source brightness.meta.id;obsintw1mproMagnitude at 3.4µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 3.4µm flux measurement has SNR<2. This column is null if the source is nominally detected in 3.4µm, but no useful brightness estimate could be made.magphot.mag;em.IR.3-4umfloatindexednullablew1sigmrpo3.4µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 3.4µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1snr3.4µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w1flux) to flux uncertainty (w1sigflux)in the W1 profile-fit photometry measurement. This column is null if w1flux is negative, or if w1flux or w1sigflux are null.stat.snr;phot.mag;em.IR.3-4umfloatnullablew1rchi2Reduced χ² of the 3.4µm profile-fit photometry measurement. This column is null if the 3.4µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.3-4umfloatnullablew1satSaturated pixel fraction, 3.4µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [3.4µm]~8 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew1frtrFraction of pixels affected by transients. This column gives the fraction of all 3.4µm pixels in the stack of individual 3.4µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew1cc_mapContamination and confusion map for this source in 3.4µmmeta.code.qualshortnullablew1mag3.4µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 3.4µmmcor.magphot.mag;em.IR.3-4umfloatnullablew1sigmUncertainty in the 3.4µm "standard" aperture magnitude. This column is null if the 3.4µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1flg3.4µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.3-4umshortnullablew1mcor3.4µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew1dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 3.4µm. Single-exposure measurements with w1rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.3-4um;arith.difffloatnullablew1ndfNumber of degrees of freedom in the flux variability chi-square, 3.4µm.stat.fit.dof;phot.mag;em.IR.3-4umshortnullablew1mlqProbability measure that the source is variable in 3.4µm flux.stat.fit.goodness;src.varshortnullablew1mjdminThe earliest modified Julian Date (mJD) of the 3.4µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew1mjdmaxThe latest modified Julian Date (mJD) of the 3.4µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew1mjdmeanThe average modified Julian Date (mJD) of the 3.4µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew1rsemiSemi-major axis of the elliptical aperture used to measure source in 3.4µmdegphys.angSize.smajAxisfloatnullablew1baAxis ratio (b/a) of the elliptical aperture used to measure source in 3.4µmphys.angSize;arith.ratiofloatnullablew1paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 3.4µmdegpos.posAngfloatnullablew1gmag3.4µm magnitude of source measured in the elliptical aperture described by w1rsemi, w1w1ba, and w1w1pa.magphot.mag;em.IR.3-4umfloatnullablew1gerrUncertainty in the 3.4µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.3-4umfloatnullablew1gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.3-4umshortnullablew2mproMagnitude at 4.6µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 4.6µm flux measurement has SNR<2. This column is null if the source is nominally detected in 4.6µm, but no useful brightness estimate could be made.magphot.mag;em.IR.4-8umfloatindexednullablew2sigmrpo4.6µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 4.6µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2snr4.6µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w2flux) to flux uncertainty (w2sigflux)in the W1 profile-fit photometry measurement. This column is null if w2flux is negative, or if w2flux or w2sigflux are null.stat.snr;phot.mag;em.IR.4-8umfloatnullablew2rchi2Reduced χ² of the 4.6µm profile-fit photometry measurement. This column is null if the 4.6µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.4-8umfloatnullablew2satSaturated pixel fraction, 4.6µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [4.6µm]~7 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew2frtrFraction of pixels affected by transients. This column gives the fraction of all 4.6µm pixels in the stack of individual 4.6µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew2cc_mapContamination and confusion map for this source in 4.6µmmeta.code.qualshortnullablew2mag4.6µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 4.6µmmcor.magphot.mag;em.IR.4-8umfloatnullablew2sigmUncertainty in the 4.6µm "standard" aperture magnitude. This column is null if the 4.6µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2flg4.6µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.4-8umshortnullablew2mcor4.6µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew2dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 4.6µm. Single-exposure measurements with w2rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.4-8um;arith.difffloatnullablew2ndfNumber of degrees of freedom in the flux variability chi-square, 4.6µm.stat.fit.dof;phot.mag;em.IR.4-8umshortnullablew2mlqProbability measure that the source is variable in 4.6µm flux.stat.fit.goodness;src.varshortnullablew2mjdminThe earliest modified Julian Date (mJD) of the 4.6µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew2mjdmaxThe latest modified Julian Date (mJD) of the 4.6µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew2mjdmeanThe average modified Julian Date (mJD) of the 4.6µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew2rsemiSemi-major axis of the elliptical aperture used to measure source in 4.6µmdegphys.angSize.smajAxisfloatnullablew2baAxis ratio (b/a) of the elliptical aperture used to measure source in 4.6µmphys.angSize;arith.ratiofloatnullablew2paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 4.6µmdegpos.posAngfloatnullablew2gmag4.6µm magnitude of source measured in the elliptical aperture described by w2rsemi, w2w1ba, and w2w1pa.magphot.mag;em.IR.4-8umfloatnullablew2gerrUncertainty in the 4.6µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.4-8umfloatnullablew2gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.4-8umshortnullablew3mproMagnitude at 12µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 12µm flux measurement has SNR<2. This column is null if the source is nominally detected in 12µm, but no useful brightness estimate could be made.magphot.mag;em.IR.8-15umfloatindexednullablew3sigmrpo12µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 12µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.8-15umfloatnullablew3snr12µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w3flux) to flux uncertainty (w3sigflux)in the W1 profile-fit photometry measurement. This column is null if w3flux is negative, or if w3flux or w3sigflux are null.stat.snr;phot.mag;em.IR.8-15umfloatnullablew3rchi2Reduced χ² of the 12µm profile-fit photometry measurement. This column is null if the 12µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.8-15umfloatnullablew3satSaturated pixel fraction, 12µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [12µm]~4 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew3frtrFraction of pixels affected by transients. This column gives the fraction of all 12µm pixels in the stack of individual 12µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew3cc_mapContamination and confusion map for this source in 12µmmeta.code.qualshortnullablew3mag12µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 12µmmcor.magphot.mag;em.IR.8-15umfloatnullablew3sigmUncertainty in the 12µm "standard" aperture magnitude. This column is null if the 12µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.8-15umfloatnullablew3flg12µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.8-15umshortnullablew3mcor12µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew3dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 12µm. Single-exposure measurements with w3rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.8-15um;arith.difffloatnullablew3ndfNumber of degrees of freedom in the flux variability chi-square, 12µm.stat.fit.dof;phot.mag;em.IR.8-15umshortnullablew3mlqProbability measure that the source is variable in 12µm flux.stat.fit.goodness;src.varshortnullablew3mjdminThe earliest modified Julian Date (mJD) of the 12µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew3mjdmaxThe latest modified Julian Date (mJD) of the 12µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew3mjdmeanThe average modified Julian Date (mJD) of the 12µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew3rsemiSemi-major axis of the elliptical aperture used to measure source in 12µmdegphys.angSize.smajAxisfloatnullablew3baAxis ratio (b/a) of the elliptical aperture used to measure source in 12µmphys.angSize;arith.ratiofloatnullablew3paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 12µmdegpos.posAngfloatnullablew3gmag12µm magnitude of source measured in the elliptical aperture described by w3rsemi, w3w1ba, and w3w1pa.magphot.mag;em.IR.8-15umfloatnullablew3gerrUncertainty in the 12µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.8-15umfloatnullablew3gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.8-15umshortnullablew4mproMagnitude at 22µm measured with profile-fitting photometry, or the magnitude of the 95% confidence brightness upper limit if the 22µm flux measurement has SNR<2. This column is null if the source is nominally detected in 22µm, but no useful brightness estimate could be made.magphot.mag;em.IR.15-30umfloatindexednullablew4sigmrpo22µm profile-fit photometric measurement uncertainty in mag units. This column is null if the 22µm profile-fit magnitude is a 95% confidence upper limit or if the source is not measurable.magstat.error;phot.mag;em.IR.15-30umfloatnullablew4snr22µm profile-fit measurement signal-to-noise ratio. This value is the ratio of the flux (w4flux) to flux uncertainty (w4sigflux)in the W1 profile-fit photometry measurement. This column is null if w4flux is negative, or if w4flux or w4sigflux are null.stat.snr;phot.mag;em.IR.15-30umfloatnullablew4rchi2Reduced χ² of the 22µm profile-fit photometry measurement. This column is null if the 22µm magnitude is a 95% confidence upper limit (i.e. the source is not detected).stat.fit.chi2;phot.mag;em.IR.15-30umfloatnullablew4satSaturated pixel fraction, 22µm. The fraction of all pixels within the profile-fitting area in the stack of single-exposure images used to characterize this source that are flagged as saturated. A value larger than 0.0 indicates one or more pixels of saturation. Saturation begins to occur for point sources brighter than [22µm]~0 mag. Saturation may occur in fainter sources because of a charged particle strike.stat.fit.paramfloatnullablew4frtrFraction of pixels affected by transients. This column gives the fraction of all 22µm pixels in the stack of individual 22µm exposures used to characterize this source that may be affected by transient events. This number is computed by counting the number of pixels in the single exposure Bit Mask images with value "21" that are present within the profile-fitting area, a circular region with radius of 7.25", centered on the position of this source, and dividing by the total number of pixels in the same area that are available for measurement.floatnullablew4cc_mapContamination and confusion map for this source in 22µmmeta.code.qualshortnullablew4mag22µm "standard" aperture magnitude. This is the curve-of-growth corrected source brightness measured in an 8.25" radius circular aperture centered on the source position on the Atlas Image. If the source is not detected in the aperture measurement, this is the 95% confidence upper limit to the brightness. The background sky reference level is measured in an annular region with inner radius of 50" and outer radius of 70". The curve-of-growth correction is given in 22µmmcor.magphot.mag;em.IR.15-30umfloatnullablew4sigmUncertainty in the 22µm "standard" aperture magnitude. This column is null if the 22µm "standard" aperture magnitude is an upper limit, or if an aperture measurement was not possible.magstat.error;phot.mag;em.IR.15-30umfloatnullablew4flg22µm "standard" aperture measurement quality flag.meta.code.qual;phot.mag;em.IR.15-30umshortnullablew4mcor22µm aperture curve-of-growth correction, in magnitudes. This correction is subtracted from the nominal 8.25" aperture photometry brightness to give the "standard-aperture" magnitude.magfloatnullablew4dmagDifference between maximum and minimum magnitude of the source from all usable single-exposure frames, 22µm. Single-exposure measurements with w4rchi2 values greater than 3.0 times the median are rejected from this computation.magphot.mag;em.IR.15-30um;arith.difffloatnullablew4ndfNumber of degrees of freedom in the flux variability chi-square, 22µm.stat.fit.dof;phot.mag;em.IR.15-30umshortnullablew4mlqProbability measure that the source is variable in 22µm flux.stat.fit.goodness;src.varshortnullablew4mjdminThe earliest modified Julian Date (mJD) of the 22µm single-exposures covering the source.dtime.epoch;stat.minfloatnullablew4mjdmaxThe latest modified Julian Date (mJD) of the 22µm single-exposures covering the source.dtime.epoch;stat.maxfloatnullablew4mjdmeanThe average modified Julian Date (mJD) of the 22µm single-exposures covering the source.dtime.epoch;stat.meanfloatnullablew4rsemiSemi-major axis of the elliptical aperture used to measure source in 22µmdegphys.angSize.smajAxisfloatnullablew4baAxis ratio (b/a) of the elliptical aperture used to measure source in 22µmphys.angSize;arith.ratiofloatnullablew4paPosition angle (degrees E of N) of the elliptical aperture major axis used to measure source in 22µmdegpos.posAngfloatnullablew4gmag22µm magnitude of source measured in the elliptical aperture described by w4rsemi, w4w1ba, and w4w1pa.magphot.mag;em.IR.15-30umfloatnullablew4gerrUncertainty in the 22µm magnitude of source measured in elliptical aperture.magstat.error;phot.mag;em.IR.15-30umfloatnullablew4gflgW1 elliptical aperture measurement quality flag. This flag indicates if one or more image pixels in the measurement aperture for this band is confused with nearby objects, is contaminated by saturated or otherwise unusable pixels, or is an upper limit.meta.code;phot.mag;em.IR.15-30umshortnullablerchi2Combined reduced χ² of the profile-fit photometry measurement in all bands.stat.fit.chi2;phot.magfloatnullablenbNumber of PSF components used simultaneously in the profile-fitting for this source. This is greater than "1" when the source is fit concurrently with other nearby detections (passive deblending), or when a single source is split into two components during the fitting process (active deblending).meta.number;stat.fitshortnullablenaActive deblending flag. Indicates if a single detection was split into multiple sources in the process of profile-fitting.meta.code.qualshortnullablesatnumMinimum sample at which saturation occurs in each band. Four character string, one character per band, that indicates the minimum SUTR sample in which any pixel in the profile-fitting area in all of the single-exposure images used to characterize this source was flagged as having reached the saturation level in the on-board WISE payload processing. If no pixels in a given band are flagged as saturated, the value for that band is '0'.meta.code.qualcharnullablecc_flagsContamination and confusion flag.meta.code.qualcharnullableext_flgExtended source flag.meta.code;src.classshortnullablevar_flgVariability flag.meta.code;src.varcharnullableph_qualPhotometric quality flag.meta.code.qual;phot.magcharnullabledet_bitBit-encoded integer indicating bands in which a source has a w?snr>2 detection. For example, a source detected in W1 only has det_bit=1 (binary 0001). A source detected in W4 only has det_bit=8 (binary 1000). A source detected in all four bands has det_bit=15 (binary 1111).meta.code.qualshortq12Correlation significance between 3.4µm and 4.6µm.stat.fit.goodnessshortnullableq23Correlation significance between 4.6µm and 12µm.stat.fit.goodnessshortnullableq34Correlation significance between 12µm and 22µm.stat.fit.goodnessshortnullablexscprox2MASS Extended Source Catalog (XSC) proximity. This column gives the distance between the WISE source position and the position of a nearby 2MASS XSC source, if the separation is less than 1.1 times the Ks isophotal radius size of the XSC source. This identifies WISE sources that are identically the 2MASS XSC source as well as WISE sources that are fragments of large galaxies.degfloatnullabletmass_key2MASS PSC association. Unique identifier of the closest source in the 2MASS Point Source Catalog (PSC) that falls within 3" of the position of this WISE source. You can use this join to towmass.data, the pts_key column there.meta.id.crosslongnullable
xpparamsParameters of 220 million stars from Gaia BP/RP (XP) spectra We present astrophysical parameters of 220 million stars, based on -Gaia XP spectra and near-infrared photometry from 2MASS and WISE. -Instead of using ab initio stellar models, we develop a data-driven -model of Gaia XP spectra as a function of the stellar parameters, with -a few straightforward built-in physical assumptions. This resource is -a VO re-publication of the resulting catalog of stellar parameters. -For bulk downloads, the covariances, the trained model, and more, see -https://zenodo.org/record/7811871.xpparams.main We present astrophysical parameters of 220 million stars, based on -Gaia XP spectra and near-infrared photometry from 2MASS and WISE. -Instead of using ab initio stellar models, we develop a data-driven -model of Gaia XP spectra as a function of the stellar parameters, with -a few straightforward built-in physical assumptions. This resource is -a VO re-publication of the resulting catalog of stellar parameters. -For bulk downloads, the covariances, the trained model, and more, see -https://zenodo.org/record/7811871.220000000source_idGaia DR3 unique source identifier. You can match this against gaia.dr3lite on this TAP service.meta.id;meta.mainlongindexedprimaryraGaia ICRS right ascension for this object.degpos.eq.ra;meta.maindoubleindexednullabledecGaia ICRS declination for this object.degpos.eq.dec;meta.maindoubleindexednullableteffEstimated effective Temperature. Note that the raw HDF5 files released by Zhang et al. (2023) give Teff in a different unit (Kilokelvin).Kphys.temperature.effectivefloatindexednullablefe_hLog of Fe/H in solar unitsphys.abund.FefloatindexednullableloggLog of surface gravity in solar unitsphys.gravityfloatindexednullableextEstimated extinction parameter. To convert to the extension at a particular wavelength, multiply this by that wavelength's value in the extinction curve, available at https://zenodo.org/record/7811871/files/extinction_curve.txt?download=1 and in the footnote.magphys.absorptionfloatnullablemod_parallaxParallax estimated from the model.maspos.parallaxfloatnullableerr_teffError in estimated effective temperature. Note that the raw HDF5 files released by Zhang et al. (2023) give the error in Teff in a different unit (Kilokelvin).Kstat.error;phys.temperature.effectivefloatnullableerr_fe_hError in fe_hstat.error;phys.abund.Fefloatnullableerr_loggError in log_gstat.error;phys.gravityfloatnullableerr_extError in extmagstat.error;phys.absorptionfloatnullableerr_mod_parallaxError in the parallax estimated from the model.masstat.error;pos.parallaxfloatnullablechi2_optχ² of the best-fit solution. Divide by 61 to obtain χ² per degree of freedom.stat.fit.chi2floatnullableln_priorNatural log of the GMM prior on stellar type, at the location of the optimal solution.stat.fit.goodnessfloatnullableteff_confidenceA neural-network-based estimate of the confidence in the effective temperature estimate, on a scale of 0 (no confidence) to 1 (high confidence).stat.fit.goodnessfloatnullablefeh_confidenceA neural-network-based estimate of the confidence in the [Fe/H] estimate, on a scale of 0 (no confidence) to 1 (high confidence).stat.fit.goodnessfloatnullablelogg_confidenceA neural-network-based estimate of the confidence in the log(g) estimate, on a scale of 0 (no confidence) to 1 (high confidence).stat.fit.goodnessfloatnullablequality_flagsThe three least significant bits represent whether the confidence in effective temperature, [Fe/H] and log(g) is less than 0.5, respectively. The 4th bit is set if chi2_opt/61 > 2. The 5th bit is set if ln_prior < -7.43. The 6th bit is set if our parallax estimate is more than 10 sigma from the GDR3 measurement (using reported parallax uncertainties from GDR3). The two most significant bits are always unset. We recommend a cut of quality_flags < 8 (the "basic reliability cut"), although a stricter cut of quality_flags == 0 ensures higher reliability at the cost of lower completeness.meta.code.qualshort
zcosmoszCOSMOS Bright Spectroscopic Observations DR2 -The zCOSMOS redshift survey used 600h on the VIMOS spectrograph spread over -five observing seasons (2005-2009) to obtain spectra of about 20,000 galaxies -selected to have Iab < 22.5 across the full 1.7 deg2 of the COSMOS field. -This part, "zCOSMOS-bright", was designed to yield a high and fairly uniform -sampling rate (about 70%), with a high success rate in measuring redshifts -(approaching 100% at 0.5 < z < 0.8), and with sufficient -velocity accuracy -(about 100 km/s) to efficiently map the environments of galaxies down to the -scale of galaxy groups out to redshifts z ~ 1.zcosmos.data -The zCOSMOS redshift survey used 600h on the VIMOS spectrograph spread over -five observing seasons (2005-2009) to obtain spectra of about 20,000 galaxies -selected to have Iab < 22.5 across the full 1.7 deg2 of the COSMOS field. -This part, "zCOSMOS-bright", was designed to yield a high and fairly uniform -sampling rate (about 70%), with a high success rate in measuring redshifts -(approaching 100% at 0.5 < z < 0.8), and with sufficient -velocity accuracy -(about 100 km/s) to efficiently map the environments of galaxies down to the -scale of galaxy groups out to redshifts z ~ 1.accrefAccess key for the datameta.ref.url;meta.datasetssa:Access.ReferencecharindexednullableownerOwner of the datacharnullableembargoDate the data will become/became publicacharnullablemimeMIME type of the file servedmeta.code.mimessa:Access.FormatcharnullableaccsizeSize of the data in bytesbytessa:Access.Sizelongnullablessa_dstitleA compact and descriptive designation of the dataset.meta.title;meta.datasetssa:DataID.Titlecharssa_creatordidDataset identifier assigned by the creatormeta.idssa:DataID.CreatorDIDcharnullablessa_pubdidDataset identifier assigned by the publishermeta.ref.ivoidssa:Curation.PublisherDIDcharindexednullablessa_cdateProcessing/Creation datetime;meta.datasetssa:DataID.Datecharnullablessa_pdateDate last published.ssa:Curation.Datecharnullablessa_bandpassBandpass (i.e., rough spectral location) of this dataset; this should be the most appropriate term from the vocabulary http://www.ivoa.net/rdf/messenger.instr.bandpassssa:DataID.Bandpasscharnullablessa_cversionCreator assigned version for this dataset (will be incremented when this particular item is changed).meta.version;meta.datasetssa:DataID.Versioncharnullablessa_targnameCommon name of object observed.meta.id;srcssa:Target.Namecharssa_targclassObject class (star, QSO,...; use Simbad object classification http://simbad.u-strasbg.fr/simbad/sim-display?data=otypes if at all possible)src.classssa:Target.Classcharnullablessa_redshiftRedshift of target objectsrc.redshiftssa:Target.Redshiftfloatnullablessa_targetposEquatorial (ICRS) position of the target object.pos.eq;srcssa:Target.pos.spointdoublenullablessa_snrSignal-to-noise ratio estimated for this datasetstat.snrssa:Derived.SNRfloatnullablessa_locationICRS location of aperture centerdegpos.eqssa:Char.SpatialAxis.Coverage.Location.Valuedoubleindexednullablessa_apertureAngular diameter of aperturedegphys.angSize;instr.fovssa:Char.SpatialAxis.Coverage.Bounds.Extentfloatnullablessa_dateobsMidpoint of exposure (MJD)dtime.epochssa:Char.TimeAxis.Coverage.Location.Valuedoubleindexednullablessa_timeextExposure durationstime.durationssa:Char.TimeAxis.Coverage.Bounds.Extentfloatnullablessa_specmidMidpoint of region covered in this datasetminstr.bandpassssa:Char.SpectralAxis.Coverage.Location.Valuefloatnullablessa_specextWidth of the spectrumminstr.bandwidthssa:Char.SpectralAxis.Coverage.Bounds.Extentfloatnullablessa_specstartLower value of spectral coordinatemem.wl;stat.minssa:Char.SpectralAxis.Coverage.Bounds.Startfloatindexednullablessa_specendUpper value of spectral coordinatemem.wl;stat.maxssa:Char.SpectralAxis.Coverage.Bounds.Stopfloatindexednullablessa_lengthNumber of points in the spectrumssa:Dataset.Lengthintnullablessa_modelData model name and versionssa:Dataset.DataModelcharssa_csysnameSystem RA and Dec are given inssa:CoordSys.SpaceFrame.Namecharssa_timesiTime conversion factor in Osuna-Salgado convention.ssa:Dataset.TimeSIcharnullablessa_spectralsiSpectral conversion factor in Osuna-Salgado conventionssa:Dataset.SpectralSIcharnullablessa_spectralucdUCD of the spectral column in the spectra served; when you have wavelengths, use em.wl for vacuum wavelengths, em.wl;obs.atmos for air wavelengths.meta.ucdssa:Char.SpectralAxis.Ucdcharssa_spectralunitUnit of the spectral columnmeta.unitssa:Char.SpectralAxis.Unitcharssa_fluxsiFlux/magnitude conversion factor in Osuna-Salgado conventionssa:Dataset.FluxSIcharnullablessa_fluxucdUCD of the flux columnmeta.ucdssa:Char.FluxAxis.Ucdcharssa_fluxunitUnit of the flux columnmeta.unitssa:Char.FluxAxis.Unitcharssa_dstypeType of data (spectrum, time series, etc)ssa:Dataset.Typecharnullablessa_publisherPublisher of the datasets included here.meta.curationssa:Curation.Publishercharssa_creatorCreator of the datasets included here.ssa:DataID.CreatorunicodeCharnullablessa_collectionA short handle naming the collection this spectrum belongs to.ssa:DataID.Collectioncharnullablessa_instrumentInstrument or code used to produce these datasetsmeta.id;instrssa:DataID.Instrumentcharnullablessa_datasourceMethod of generation for the data (one of survey, pointed, theory, custom, artificial).ssa:DataID.DataSourcecharnullablessa_creationtypeProcess used to produce the data (archival, cutout, filtered, mosaic, projection, spectralExtraction, or catalogExtraction)ssa:DataID.CreationTypecharnullablessa_referenceURL or bibcode of a publication describing this data.meta.bib.bibcodessa:Curation.Referencecharnullablessa_fluxstaterrorStatistical error in fluxstat.error;phot.flux.density;emssa:Char.FluxAxis.Accuracy.StatErrorfloatnullablessa_fluxsyserrorSystematic error in fluxstat.error.sys;phot.flux.density;emssa:Char.FluxAxis.Accuracy.SysErrorfloatnullablessa_fluxcalibType of flux calibration (ABSOLUTE, CALIBRATED, RELATIVE, NORMALIZED, or UNCALIBRATED).ssa:Char.FluxAxis.Calibrationcharnullablessa_binsizeBin size in wavelengthmem.wl;spect.binSizessa:Char.SpectralAxis.Accuracy.BinSizefloatnullablessa_spectstaterrorStatistical error in wavelengthmstat.error;emssa:Char.SpectralAxis.Accuracy.StatErrorfloatnullablessa_spectsyserrorSystematic error in wavelengthmstat.error.sys;emssa:Char.SpectralAxis.Accuracy.SysErrorfloatnullablessa_speccalibType of wavelength calibrationmeta.code.qualssa:Char.SpectralAxis.Calibrationcharnullablessa_specresResolution (in meters of wavelength) on the spectral axismspect.resolution;em.wlssa:Char.SpectralAxis.Resolutionfloatnullablessa_spaceerrorStatistical error in positiondegstat.error;pos.eqssa:Char.SpatialAxis.Accuracy.StatErrorfloatnullablessa_spacecalibType of calibration in spatial coordinatesmeta.code.qualssa:Char.SpatialAxis.Calibrationcharnullablessa_spaceresSpatial resolution of datadegpos.angResolutionssa:Char.SpatialAxis.Resolutionfloatnullablessa_regionRough coverage based on location and aperture.pos.outline;obs.fielddoubleindexednullabledatalinkA link to a datalink document for this spectrum.meta.ref.urlcharnullable
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta b/pyvo/discover/tests/data/image-with-all-constraints/GET-reg.g-vo.org-tables-Mffx+yRe.meta deleted file mode 100644 index fade371ce5055631c9839343430de5932fcd1b8b..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1431 zcmY*ZQBNC35Jru`7N#*2B`<9%KSBy;`$&l3sS%`Ulg3ztwo=tpR;7$=uHD%%{RZ-{x+*Cv%ed=W132HT__fci0tcs zO+6+akyO@fOL||B(#lg>7NIUAIqwNq^j)SXQ;ANl=rjqn{mbrtus7DMF{OnhYnq`* zQwnt=GUPPRBuY{=k3Gk^TUzo=4N2}(hO?7wWX;ya-1lPPtA}xsT~cKKKzT*-iX;|q ztHq;Je)8?xj_)0Lep_EBN>lU`1s%WZ9e7=rQ;WF9g=(j>&!aaY+iUxW?QbY(`(6J@ zyL)te;2%FdXuo`O;o>(!k!i~GzMkgD+c>Gri<#NbG|`>OI7Mio0#mOrvgW}YEjAY6 zrMK{Jv-1+hv)~;78Avgi&hgqY4Ymku%?o&AP>}+*)<9Cufm>B!nYK129gE1CdoN#H z;C~@gYrc%N&W}4CNh5ExetQP=upO5fdYu0~o z#`Ds6mQQ~?>-4-sFQThwy{|?=@WdYy_aX;c*9U@wDXx%p4!m9u*zbIwWW{9HA=u(! zNV&elYwLOGS+cq{`Yp-#+7S&?@Uqtqq|00@GqETW@Uq99$8KjGtYl?B!2l;q^m!x(d* zZ<-9P&ma=57{m%AO#%-#@=bH#zUQRC8%W+UHTM97-Bk#}?ux{$*f@<5{{io0@5?JO zos3Bo8V6SIgKVQjq9GN0bvC1C>d40cl*GqauCkD%OKCU^C$1l7vNJ6fVuZ5A1huzC HP -Definition and support code for the ObsCore data model and table.ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe IVOA-defined obscore table, containing generic metadata for -datasets within this datacenter. -The calib_level flag takes the following values: - -=== =========================================================== - 0 Raw Instrumental data requiring instrument-specific tools - 1 Instrumental data processable with standard tools - 2 Calibrated, science-ready data without instrument signature - 3 Enhanced data products (e.g., mosaics) -=== ===========================================================High level scientific classification of the data product, taken from an enumerationData product specific typeAmount of data processing that has been applied to the dataName of a data collection (e.g., project name) this data belongs toUnique identifier for an observationFree-from title of the data setDataset identifier assigned by the publisher.Dataset identifier assigned by the creator.The URL at which to obtain the data set.MIME type of the resource at access_urlEstimated size of data productObject a targeted observation targetedClass of the target object (star, QSO, ...)RA of (center of) observation, ICRSDec of (center of) observation, ICRSApproximate spatial extent for the region covered by the observationRegion covered by the observation, as a polygonBest spatial resolution within the data setLower bound of times represented in the data setUpper bound of times represented in the data setTotal exposure timeMinimal significant time interval along the time axisMinimal wavelength represented within the data setMaximal wavelength represented within the data setSpectral resolving power lambda/delta lambdaUCD for the product's observableList of polarization states in the data setName of the facility at which data was takenName of the instrument that produced the dataNumber of elements (typically pixels) along the first spatial axis.Number of elements (typically pixels) along the second spatial axis.Number of elements (typically pixels) along the time axis.Number of elements (typically pixels) along the spectral axis.Number of elements (typically pixels) along the polarization axis.Sampling period in world coordinate units along the spatial axisNature of the product's spectral axis (typically, em.freq, em.wl, or em.energy)URL of a preview (low-resolution, quick-to-retrieve representation) of the data.Name of a TAP-queriable table this data originates from. This source table usually provides more information on the the data than what is given in obscore. See the TAP_SCHEMA of the originating TAP server for details.AAAABWltYWdlAAAAAAACAAAABFJBU1MAAABPcm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9iazEuZml0cy5negAAAD5ST1NBVCBQU1BDQyBST1NBVCBTb2Z0L01lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsxLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAywAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+SqAaWYHPGH/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMS5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAxyb3NhdC5pbWFnZXMAAAAFaW1hZ2UAAAAAAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENDIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkwLTEwLTE5IDA4OjA3OjUxLjUwMDAxMgAAAGNpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfYmsyLmZpdHMuZ3oAAAAAAAAAemh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAVgAAAAAAAAAAQGCGNfELQB5AJnyxfWaX7kAZmZmZmZmaAAAAflBvbHlnb24gSUNSUyAxMzUuNDA0OTMxODI1OSA4LjA0NjgwNjc4NDggMTM1LjQ3NjkyMjYzMTkgMTQuNDE3NDQxODM4OCAxMjguODk4NTA1NDUyMiAxNC40MTc0NDc3NzE1IDEyOC45NzA0ODY5MjkyIDguMDQ2ODEwMDQ3M0BGgAAAAAAAQOeG6tdfMa9A54bq118xr3/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0MAAAAAAAACAAAAAAAAAAIA////////////////////////////////QEaAAAAAAAAAAAAAAAAAh2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAxyb3NhdC5pbWFnZXMAAAAFaW1hZ2UAAAAAAAIAAAAEUkFTUwAAAE9yb3NhdC9pbWFnZV9kYXRhL3JkYV84L3dnOTMxNTI0cF9uMV9zaTAxX24xX3AxX3IyX2YyX3AxL3JzOTMxNTI0bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENDIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTEuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAA0AAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT5KoBpZgc8Yf/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAT3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAA5Uk9TQVQgUFNQQ0MgUk9TQVQgTWVkaXVtIFgtUmF5IDE5OTAtMTAtMTkgMDg6MDc6NTEuNTAwMDEyAAAAY2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfOC93ZzkzMTUyNHBfbjFfc2kwMV9uMV9wMV9yMl9mMl9wMS9yczkzMTUyNG4wMF9pbTIuZml0cy5negAAAAAAAAB6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAYAAAAAAAAAABAYIY18QtAHkAmfLF9ZpfuQBmZmZmZmZoAAAB+UG9seWdvbiBJQ1JTIDEzNS40MDQ5MzE4MjU5IDguMDQ2ODA2Nzg0OCAxMzUuNDc2OTIyNjMxOSAxNC40MTc0NDE4Mzg4IDEyOC44OTg1MDU0NTIyIDE0LjQxNzQ0Nzc3MTUgMTI4Ljk3MDQ4NjkyOTIgOC4wNDY4MTAwNDczQEaAAAAAAABA54bq118xr0DnhurXXzGvf8AAAH/AAAA+AcARlc79KT4qoBpgtnu9f/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQwAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ARoAAAAAAAAAAAAAAAACHaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzgvd2c5MzE1MjRwX24xX3NpMDFfbjFfcDFfcjJfZjJfcDEvcnM5MzE1MjRuMDBfaW0yLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAADwAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfaW0xLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMS5maXRzLmd6AAAAPlJPU0FUIFBTUENCIFJPU0FUIFNvZnQvTWVkaXVtIFgtUmF5IDE5OTMtMDQtMjUgMTc6Mjc6NDMuMTI5OTk2AAAAW2l2bzovL29yZy5nYXZvLmRjL34/cm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3oAAAAAAAAAcmh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9iazEuZml0cy5negAAAAppbWFnZS9maXRzAAAAAAAAABsAAAAAAAAAAEBgm0VEY4I0QCen25QxnA9AARERGgO3RQAAAH5Qb2x5Z29uIElDUlMgMTMzLjkzMzQxNjIxMDQgMTAuNzYzNTkwMDAxMSAxMzMuOTQxODc5OTg5MiAxMi44OTIxMjgzMzE5IDEzMS43NTgyNzQzODUgMTIuODkyMTI4OTIyIDEzMS43NjY3MzcwNjA3IDEwLjc2MzU5MDQ5MTJALgAAIY3vQUDn+ddIWyTCQOf510hbJMJ/wAAAf8AAAD4BwBGVzv0pPkqgGlmBzxh/+AAAAAAAAAAAABJwaG90LmZsdXg7ZW0ueC1yYXkAAAAAAAAABVJPU0FUAAAAC1JPU0FUIFBTUENCAAAAAAAAAgAAAAAAAAACAP///////////////////////////////0AuAAAhje9BAAAAAAAAAH9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsxLmZpdHMuZ3o/cHJldmlldz1UcnVlAAAADHJvc2F0LmltYWdlcwAAAAVpbWFnZQAAAAAAAgAAAARSQVNTAAAAR3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMi5maXRzLmd6AAAAOVJPU0FUIFBTUENCIFJPU0FUIE1lZGl1bSBYLVJheSAxOTkzLTA0LTI1IDE3OjI3OjQzLjEyOTk5NgAAAFtpdm86Ly9vcmcuZ2F2by5kYy9+P3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMi5maXRzLmd6AAAAAAAAAHJodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2dldHByb2R1Y3Qvcm9zYXQvaW1hZ2VfZGF0YS9yZGFfNC93ZzIwMTMyNnBfbjFfcDFfcjJfZjJfcDEvcnAyMDEzMjZuMDBfYmsyLmZpdHMuZ3oAAAAKaW1hZ2UvZml0cwAAAAAAAAAVAAAAAAAAAABAYJtFRGOCNEAnp9uUMZwPQAERERoDt0UAAAB+UG9seWdvbiBJQ1JTIDEzMy45MzM0MTYyMTA0IDEwLjc2MzU5MDAwMTEgMTMzLjk0MTg3OTk4OTIgMTIuODkyMTI4MzMxOSAxMzEuNzU4Mjc0Mzg1IDEyLjg5MjEyODkyMiAxMzEuNzY2NzM3MDYwNyAxMC43NjM1OTA0OTEyQC4AACGN70FA5/nXSFskwkDn+ddIWyTCf8AAAH/AAAA+AcARlc79KT4qoBpgtnu9f/gAAAAAAAAAAAAScGhvdC5mbHV4O2VtLngtcmF5AAAAAAAAAAVST1NBVAAAAAtST1NBVCBQU1BDQgAAAAAAAAIAAAAAAAAAAgD///////////////////////////////9ALgAAIY3vQQAAAAAAAAB/aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2JrMi5maXRzLmd6P3ByZXZpZXc9VHJ1ZQAAAAxyb3NhdC5pbWFnZXMAAAAFaW1hZ2UAAAAAAAIAAAAEUkFTUwAAAEdyb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAADlST1NBVCBQU1BDQiBST1NBVCBNZWRpdW0gWC1SYXkgMTk5My0wNC0yNSAxNzoyNzo0My4xMjk5OTYAAABbaXZvOi8vb3JnLmdhdm8uZGMvfj9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5negAAAAAAAAByaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9nZXRwcm9kdWN0L3Jvc2F0L2ltYWdlX2RhdGEvcmRhXzQvd2cyMDEzMjZwX24xX3AxX3IyX2YyX3AxL3JwMjAxMzI2bjAwX2ltMi5maXRzLmd6AAAACmltYWdlL2ZpdHMAAAAAAAAAIAAAAAAAAAAAQGCbRURjgjRAJ6fblDGcD0ABEREaA7dFAAAAflBvbHlnb24gSUNSUyAxMzMuOTMzNDE2MjEwNCAxMC43NjM1OTAwMDExIDEzMy45NDE4Nzk5ODkyIDEyLjg5MjEyODMzMTkgMTMxLjc1ODI3NDM4NSAxMi44OTIxMjg5MjIgMTMxLjc2NjczNzA2MDcgMTAuNzYzNTkwNDkxMkAuAAAhje9BQOf510hbJMJA5/nXSFskwn/AAAB/wAAAPgHAEZXO/Sk+KqAaYLZ7vX/4AAAAAAAAAAAAEnBob3QuZmx1eDtlbS54LXJheQAAAAAAAAAFUk9TQVQAAAALUk9TQVQgUFNQQ0IAAAAAAAACAAAAAAAAAAIA////////////////////////////////QC4AACGN70EAAAAAAAAAf2h0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9yb3NhdC9pbWFnZV9kYXRhL3JkYV80L3dnMjAxMzI2cF9uMV9wMV9yMl9mMl9wMS9ycDIwMTMyNm4wMF9pbTIuZml0cy5nej9wcmV2aWV3PVRydWUAAAAMcm9zYXQuaW1hZ2Vz
A datalink service accompanying obscore. This will forward to data -collection-specific datalink services if they exist or return -extremely basic datalinks otherwise.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-dc.zah.uni-heidelberg.de-sync-3tsfhmwKsBLPj4lO.meta deleted file mode 100644 index d83724cc9471365cb6f05e17f972649c210175c9..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1910 zcmaJ?-*4MC5YCpg$(pWd)~(pE74RNhq;)JSa+=fy@(|cr)27W2Cq=gb13^i2q(%}| zl8WO31=g2g0r)oVf7&0hKV~0o*=~n*elU5*yW{Em?vB6C{dqP&GyJ_ZD|%5XstQR0 z9x}7{m!6Lp4VjQe-xBO~!K9LoRH6t}A(+*+sbo(w$ub$M_?&g(K$$ zUNUjc1UARz=1zyUcaIyM({j9u>c>*C@Fnvbp6fIn*ZRzbR3V|c&TzT&oM)>QZ=>=9 z^DCa~tykREqo(_)xmkJq{KVQ{4|t|nrs`^t!|!^#6isa->>($Nb7)fSgONXv|KNsY4}-e zyW-{;3}>QRE=iK@q0v(+rgY7doTH2e$k9?%I=zC4zSUtpS|n=ZbvQCB`wQifF(m_v z%KROr)(gDW#shPSR>gMBZ4oNT#A07xk3e>rqzALl(a30567rPB85G}^iZT)@GPGCR zi)~TkhTG+FCOug_2%hyffC+Hy-mYGX)4?3D8y#JnVU(b<@_s!F-pZ{isAML(1QCJFk z&gbF4{Mh?sW~RGy^kV1uWGm!H1rvk2&$jm;Z*6yup52AM`_qCK-gd1gcv_3k zId!-%15CEs%iW#sP7O1KBHs{Gk=Qv=ZFZ{OW}Kp3u-3NsJ8*xv2DPn8U@al$JkAtW zSUhQWkFiv}c1;pNM{CG}s@JmnAQnM_NdGcjYp&bVwKezl0ZwuYZ(&FDq7x${vo zgtaW9@TGkg7VvW9cnO&K#YlaFST4{3_5tCU*)MD>rBnqGX8XQgBH&y?AKXE|X{x^wWx-v$bOM*B_g4Mt?RPb9%-^MN}yB4#h=YkCG!QP8o-C@5^yj zVF-t@uvj9Wc`|H@fo(awZ-UVj+bbksLg9G9R_=wJ0>jCvmq>sYl1v^*b6NO>^A8>~ B#(e+) diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C deleted file mode 100644 index 6e6f77bd..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C +++ /dev/null @@ -1,28 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaE4jcIPo1C.meta deleted file mode 100644 index dbc1df27d052f341e6b5d1e812cdfbaeb440ad43..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3241 zcmds4O>YxN7>-IvQj!u<)Jj!Bat}d)#cO->g^@TI$AN%j2it*is7B-6v3JROcbS>B z<4Q>7QZ>@vy1n$!pVD)GM1M@5*ci+eF z;%I>g>2nrG%ck$T%#@DrfoHkNA(B}W+7|S#Nlrb{V?571=ytq*9IbUGxY`uAXxgE7 z!mRjbh!>0x8ONcW9d7T@>eF_?(961!lOsn+X1!wFf>G2r^`hdLx2S|c^LxqT_Mz|H z&lx+peb&txMPn;hEI%x5Kio2MPYyeZe#P`X$vl~t;{bds)eP(;;5Re~T*sv9VujQE z(3iC9GVOHWf;SZ1XfbnI9DOx$9~t=Oi9W^OB(2o1&F&j`=!pBL+5|OtNXlPkTfWW zv1i8iXZF=3Z1$49d{@QfS_lW{X&={*qie?ssH8wX7{6>5O8Sm&vEgn>>vy|bMvu|l z(HMHY!lqs-Ap#q9#|uyIDnG7L(`11>7v0rLikZcBt^cDF+|OC8=OQ}yb6u`D7gA0f zQU=`SUg4g4a}BZa(yRi2$jpEf#)3R`k&ue;`Xq=h^ZL>TViLxBhL|tyl#~3pINslV z81K<&l<)a`kcWGdv`z9-#eE3{nJ75Y7MF4F)2)nEd2#(*E5as&USo;vc<7fEE6iol%f%>*p9_A zBMp#!fucs~63ZV@#{=Tq43SA9p@&j)dX7qPX!tsN?THWHoJBWgZ!%%e=b~FPq+pUb z9-0Mpq0M!1v$N>S58nqAQBtCqi8ez5?n@sn1m3)=oPy_-kq|1hH%Qk-Juxe@T*P;Q zqps_Z&fyx-Jn{Td{Or${f3vV_KYbV5Rt7}#UEdnV-~YZaH`l7YIIgujk1YR1$oTk9 zz0!E{sIvE>eh2v0>qqTcy;kk47c0)tcdT`zs-X!I)f&`U*gluUqk{xW-Z;`tfGh!t z%ZALI@L5cl+zC|kNKt5iNFzp&P6}aiM$tcsU~i`&OSFc8YGbJZPT!Uyd7rkXnK^#Q zAxtGGm5M;5h#_^u%)&lY6TgQh)2BQUH=;w&Am>vr@0M zt2G=|WeOxfYVNwRn|#YkmpW}$(r+-IdTqa>HIF;BmiDZ9(9l2y5wz>LjvQZ12bVJ5qb9qUjJjwy7DgC)7vmSx zs*<&sq>g(roscFG=uv24pF)Tc#S_X`Piw6jI8ZvN8gi;SowmNYmlTY#f9~?eK5CpE zs#(8o?5}SXQHgn#^}AZ7v8R<1E>)eLZ(;{SjhpsN@U+N54}c!8b`o$DZy6S9i4KTM)l{2}PUWD{2I8<;#qW-)@#;aVT33Cbw7I3=Qc3+5 zbvzO=08AfK0~!DmG#!OL6 zbth%ylUDQiNPGMmM_lXw-H+Ae!?GaMTD^ok4X{bG_=i|T*NK{6*c#LV?t5_~RO?5Q z4%m$w(X#5#1bd7op)vNd{}l0A*bVi60DjkLc>n+a diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU deleted file mode 100644 index 443eece0..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU +++ /dev/null @@ -1,7 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAsaXZvOi8vb3JnLmdhdm8uZGMvX19zeXN0ZW1fXy9vYnNjb3JlL29ic2NvcmUAAAAcaXZvOi8vb3JnLmdhdm8uZGMvcm9zYXQvcS9pbQAAACxpdm86Ly9vcmcuZ2F2by5kYy9fX3N5c3RlbV9fL29ic2NvcmUvb2JzY29yZQ==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEQ0AwcjQU.meta deleted file mode 100644 index 42325ca05bdfde348471a4af0967dcc6d1b5e0fc..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3249 zcmb^!U2hvjFoLuRPD5HMkPuW_{L-Z4?ri6)33iZ)U7FUhQ`>C;37z)t*1m1dx7Xdh zI4-J0Ul5h*pu0pS|);ce;<2kboV^!jo1cF4Ur`q-5+*fR`HhWZec)fpce5(kEu_;&2R zXKTu%E7-P4AkW2lrJiDDQNA{OMuT}`J}eBy}f&T2k(+WX$zMIgY7bQ?Ay03Qno6ac17u; z(qj?ojGa(bNLQ!fouaN~aTNy%(LKy(5neC@2AMYj3sh9~l<5hOMAsW+fI+*I>o_IL zN)j^4CsNoLlKDr-&VgOo-QJ2{LUqHjT-r6UFsBsl=!#1nk||jMvSp}!sBqI^BTRij ze3T(FNoMFnMbZIPbpS7XkX`%Y;?2wG>g*;Hc7HDVc!m^2n$(A$f<1W6^T4u~(R&x~ z0}LTlqKFOM$P74>3_1;X^OAB3eBT}mp@MnUv^*#~;$)hOcnxsa^Vs+tt{u&rJ{!mP ze*5Nk5?b!v=dtT#Ks0YLXA*z$-Q~GCO?zE@msJubeWO7|z*KK!{vJA)Dn1^OTCv-F z@UYqI7ncjm1&2Kd37;$%-kkVWz5Qh(yWV)vdXs`d>+aWyJ4c9f=zKt;27yb1zYrmGuXET&(3H$D@ECS<>IhWtA&(5CI(FJL+ zVSr%m-;3dN=uYL#l&$6XS4w+)x7lr`re%7YY8upTQjts`$C}){pu(H<^uyy;r`||h z4fd}?$HAjLIK9a?KwR-NG@#HFldM#*%E;>HFv$=Uv;ezn#j;*1qI^8pilH26w~L?e z7pk9V8iK*)gf?-|m`WF6C{z|qbjtK>DCT0&mR`}zsk^dyG#-!joI#Bwq-h}ZQKw)3 zqSeg#)bpD~1Pb}0Ry@ZE*?@IuSq5Agz@$2laaz_lGUB~6K`$_jH>e~xl2Jw2 zsi1QUb%m;l{py6OcMhAa20Coiiqt70%sHM2`V1P#Ciq0no|HZGsao6)T+E9ok7W^s zwo@y@N`RsG26|FH$qOL3(d->`50CqYop$mPN-J3)Hb6G^9SY@)RF+elh$L!N)0PWrw81tY)Ox)L*%Ck_CGoehh~72TfP%Fk9X4@0RQtsUOGsrNx1%K! zmOxW&EW(8C1^|y*I>5jmEgh?GH_1L&GFGE`mCQhPepig6cV_EiG#9&}8_M_vOj+}3 zs*ow^h%i95^XUrvt3x@gW&&^vX0jYi)an6$4LHFgI9@Vs!WGM+n&4+@8%h??XvMVQ P&xJYtZxO!?tx*31HxX6+ diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ deleted file mode 100644 index 7bbb947d..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ +++ /dev/null @@ -1,27 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL3Jvc2F0L3EvaW0AAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMUk9TQVQgaW1hZ2VzAAAAHwBSAE8AUwBBAFQAIABTAHUAcgB2AGUAeQAgAGEAbgBkACAAUABvAGkAbgB0AGUAZAAgAEkAbQBhAGcAZQBzAAAAAAAAAIEASQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIABiAHkAIAB0AGgAZQAgAFIATwBTAEEAVAAgAHgALQByAGEAeQAgAG8AYgBzAGUAcgB2AGEAdABvAHIAeQAuACAAVABoAGkAcwAgAGMAbwBtAHAAcgBpAHMAZQBzACAAYgBvAHQAaAAKAHAAbwBpAG4AdABlAGQAIABvAGIAcwBlAHIAdgBhAHQAaQBvAG4AcwAgAGEAbgBkACAAaQBtAGEAZwBlAHMAIAB0AGEAawBlAG4AIAB3AGkAdABoAGkAbgAgAHQAaABlACAAYQBsAGwALQBzAGsAeQAgAHMAdQByAHYAZQB5AC4AAAAvaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9yb3NhdC9xL2ltL2luZm8AAADzAFYAbwBnAGUAcwAsACAAVwAuADsAIABBAHMAYwBoAGUAbgBiAGEAYwBoACwAIABCAC4AOwAgAEIAbwBsAGwAZQByACwAIABUAGgALgA7ACAAQgByAGEAdQBuAGkAbgBnAGUAcgAsACAASAAuADsAIABCAHIAaQBlAGwALAAgAFUALgA7ACAAQgB1AHIAawBlAHIAdAAsACAAVwAuADsAIABEAGUAbgBuAGUAcgBsACwAIABLAC4AOwAgAEUAbgBnAGwAaABhAHUAcwBlAHIALAAgAEoALgA7ACAARwByAHUAYgBlAHIALAAgAFIALgA7ACAASABhAGIAZQByAGwALAAgAEYALgA7ACAASABhAHIAdABuAGUAcgAsACAARwAuADsAIABIAGEAcwBpAG4AZwBlAHIALAAgAEcALgA7ACAAUABmAGUAZgBmAGUAcgBtAGEAbgBuACwAIABFAC4AOwAgAFAAaQBlAHQAcwBjAGgALAAgAFcALgA7ACAAUAByAGUAZABlAGgAbAAsACAAUAAuADsAIABTAGMAaABtAGkAdAB0ACwAIABKAC4AOwAgAFQAcgB1AG0AcABlAHIALAAgAEoALgA7ACAAWgBpAG0AbQBlAHIAbQBhAG4AbgAsACAAVQAuAAAAEzIwMTUtMDctMDlUMDg6MDA6MDAAAAATMjAyMy0wNC0yMFQxMjowNjo0NQAAAAAAAAAHY2F0YWxvZwAAAAdiaWJjb2RlAAAAEwAyADAAMAAwAEkAQQBVAEMALgA3ADQAMwAyAFIALgAuAC4AMQBWf8AAAAAAAAV4LXJheQAAADRodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3Jvc2F0L3EvaW0vc2lhcC54bWw/AAAAFml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAA=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaER+vi%QiZ.meta deleted file mode 100644 index db8885a89fbe9062e84410e30372ec96280595c7..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3107 zcmds3U2oG?7_LTXJK9k?wrSHq$}WmpOq`E?K#;fyX$pljDM5C z%_O98Gp&;E=KY)ffc=R5m_5gKlEOvDdb!Ao&-?oQI`8){^M8E1GMD_`#T(JGkW_|( zn7+m0=YK_uHlr5fB93ly_BLcf3SCGZnlj`}VQW;d15YqdIMNxiJ;#*s@A2mQ_+1<= z5Fvfe;%M3QU6+~C@jdV?w>U&HYeL(G-ZjaoCwh$MnFrmD*N>yM?gUq#;ucLi^iG%+ z{|fPf@gd_lbh5+kJz9I(DU|h!Ue3vpBP6q4F{4l}>RWnI@yuIP!l3!R>?-;d)AuCvWL}N~@U7G`u$zG2(I9Xgld6jqPV+-w zQp081>A(eVD2!+^b6OmIJ#ily_~wZ|#or|D)UPe$4Lo$j{nPQpfg8~hnG&u}1n2|A z#)ThOk2nh`9GOX&u`LXkw0#TrJZg2iadai*ZXDgRr3@Yx3Y_)zK8)3U-Y-ZR6vWsw zWBW7vY7#bk$zI-6F}W7P!Fk%p_2cN;u>z_okPpT$TZNLot6OY%zohjIW4qjAGigO|5#35zC zZSEHCsxQ|N8!yc&0Eo;CIAJWvQx^%T2(M3q=rXS_Z6GFLY-EV}($3DVBE2}?KYSSP z(P)(K`FxOvdy}+H@>0cp2?gYzII2Q!Oyf31tz`idwS?#y<+IQ&lE6nwjbWq;m!2}c z0ZDXokM(Hi%9QIUCCh3Jsp2syOo}Z14Qbai%az@o_zY!>W2smnRFEk}Gg`47i)BWZ zLG}fT8l_7te?T1%i0?B*CW(X|O3mpxD#4-Qo9weEKKybP-I#sJggu{&Zq1N_N#b~D z7Sx3{*Tv1wqAx%E9#BL{iDD+&3<yOUin$bM*{89Yu&zFC*(6FDri)||dqItu&#_^9|EzHfe>o1P$o$e#ce-Sc1zSF2S zpFFDWy=dG4zWw@9r{1X7y6eTNGxQy6yMU%ZOXAT%0wrG@=_WvyfW&1( z=1%x5CQR-Gs(GX+v_GT~BSpG2^?Q;;QE!$7sM)BvY%OObp}Thq)OKjaXm z5|m0sAX3DTx?yHvAF7GpLzC%Ko`@UKAv36#oN-T0!%fk}IT|vd{r-CSL9JD7)H}60 zj;b;R5+F5qy?j4;DoU3+ZB^4J7;7(Enqa{clhSF`jy4mK+~HqUVmx^kY$d7tFQxOG zj89YQc(ONj>!nmqCHx14+)s1o@(PuNPg97#K|V^yOR4=xjzB#3+pR;qILFLOGZ0X- z+C6Sp8(O2j-_=^j-FjPl);efvpn?c$IIbhd7t_I|jQ6O?E+(Tc+Kq(~hTg^a#k4}2 zM4)=31oXaf@_W=feL=CCbFYn{Qnd)f7I0}g}+ZPT^T#d4+ zK!&DOn|q3{q^)o5X|-0fTRmuYfH-W`@V~37t9Hh-23g7jJ_ddg*D%oN2`Ur|R-KVx zLz9AFvjE^ah7K6~(ejacx0%2|$MoNb=G9~a+4=1(jy|6)Xwh73hju9A_ZWZVZE6sa z&VczqHYZ~b&D?T0f+&DnB+1kstDQi#aYhF?UL_{uie*WS)>E~nBr9LEN=&Tt7&zHB KAD@LrsQ&{8%{`a^ diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm deleted file mode 100644 index e14ba64d..00000000 --- a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm +++ /dev/null @@ -1,28 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAALGl2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vb2JzY29yZS9vYnNjb3JlAAAAEnZzOmNhdGFsb2dyZXNvdXJjZQAAAA9HQVZPIERDIE9ic2NvcmUAAAAeAEcAQQBWAE8AIABEAGEAdABhACAAQwBlAG4AdABlAHIAIABPAGIAcwBjAG8AcgBlACAAVABhAGIAbABlAAAAAAAAAGAAVABoAGUAIABJAFYATwBBAC0AZABlAGYAaQBuAGUAZAAgAG8AYgBzAGMAbwByAGUAIAB0AGEAYgBsAGUALAAgAGMAbwBuAHQAYQBpAG4AaQBuAGcAIABnAGUAbgBlAHIAaQBjACAAbQBlAHQAYQBkAGEAdABhACAAZgBvAHIACgBkAGEAdABhAHMAZQB0AHMAIAB3AGkAdABoAGkAbgAgAHQAaABpAHMAIABkAGEAdABhAGMAZQBuAHQAZQByAC4AAAA2aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YWJsZWluZm8vaXZvYS5PYnNDb3JlAAAAEABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByAAAAEzIwMTEtMDMtMjVUMTA6MjM6MDAAAAATMjAyNC0wMi0wNlQxMDoxOTozMwAAAAAAAAAAAAAAAAAAAAB/wAAAAAAAAAAAACNodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL3RhcAAAABppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eAAAAAx2czpwYXJhbWh0dHAAAAADc3RkAAAAAA==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaETdYJc6Lm.meta deleted file mode 100644 index b9bc24fe8a0f39627c41fecd494892ddf75d455d..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3204 zcmds4U2oG?7_LTXJK9k?v`N!I$}WluCeBw|2oe_|O`(t`B}rjiOh?D|No?xa=A7fC znS?ZMrd9IYyq~lC{fPaTJ;!#E!bQh=xhRUy`}+Ml?{|J#{A04VkbK_9ThXeJREC0> zzQy7fe?`kSqZZ>Lj&5@HE@VOqT}U39GUQBQ>r}7dYE;FU$d*E4ZbBJWtl(qxC8$`}~{hYxS=TgdvL&|{L z+$-EuZ>}LWUYb<^5Sck}!dQ@}E)r4^UY`chW!^yAKup8f%n*yE-JOaey*S=Kd>rrb zc%1M1e3*xOleA6pQpJ4*1>~PNszPqe;xqiY)yNY1cQ))!m)=3}uUBsaPdckQqfQTC*LCWk!}k z_7#d6rAsV-NF5J|?=wUuiG&_X&FMQT!J*;X?6oI8esdPxn7_${y;z8D&5?ph;&^Bl z)P*+J#m&y5uRnetP((?IVkX)Q3AitPv=Dgns&WdRSH?o9c-l&IMQLRCph3#`mJUUFE7)=QXB7RD2=;CUvP5ebs5X`w;0$ajlJ{wAnw#T?9KuwB zQmF_;iWpHh%q$#0HSzmsG6TvJabr4S2KACN?x|_GDY`gELnd@E*epM+w`mxA0*$Z(xpz7TKWwp+N-uESTMt+bXu*e%|#@4_*az}Po4!^N$UPf={zUn z^OQQC?9beKDU~w`|3M-5)7-hdLM7qz6ryjCPtx&HYCn-95YPQi`w$P#G4s+41k|ea zjytuc)@>&VH)bZ{x-eQL6c$*7BVV_}4$cQJl3ZBnwT z!Cg!yq)7x?6gt@F5Mn~{g!1*XMyCM|R8F!dkWh6F&2>(gsuxt6Dv^Jtb)*AP8Ftb^XE2>8d)b(5@vcu%VQY z*W0aL?V!~K;;>!E@2)D}`a!4OR3%=jY%91_QoltV50rOO;iiv)faM^=oD*EtcT1Jx zPW552QdOUaEMIz{J!$k_HySNX1gS&NRVbHzw9`I5(w@A*@qgcH)lkD8 zAk@aZf^Y>`l3DyyETZc~jV3GvYPa^ixD~3+0^QuSvG%s2Rn>Y4RzN8TRu=%SW9Wdv zAFUp#XNL)F3|KF=qD3`2L3V!qi=!{+8(_2$+o2uG_yguEd6ybQq%&kbkge%l#k8;- zjvxx)mPxV}Ow`h$<^-cd9Iq0SamBKtX7{PugOZ&xS|=v{FJPi&e;4Aj& -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAABEaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAAgaXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAAAMdnM6cGFyYW1odHRwAAAAA3N0ZAAAAAA=
\ No newline at end of file diff --git a/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta b/pyvo/discover/tests/data/image-with-all-constraints/POST-reg.g-vo.org-sync-zBFGPNaEbnXsIVpl.meta deleted file mode 100644 index 262c664b5bbc461ae875face2ad7876c3de816d5..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3117 zcmds3UvJY^6t6~UJK9k?v`N!o$|e=Hm^g{kmIjH3kfu-wNl8)|57X6+eG{8Hwz>DZ zX(l0!muZ#!Ht*x?eIH^UX1{AYN#UVmeOzS4_Z**p_x%55{*ND4=91sLcq3XClFCpJ z)3;ds?5}9iX4GO_#L-R8-iAy_p$o}FQ-+)=Y>f(b;0fjlM>;2L&oO2Ed%XEReiugz zL`a{rI9fJ+*JY-3d=EU!Ee?^)n$WhPcTIBYi9X|b=0UgP4dQ66JHgebxJAdGn()NR`Qtt8duA*NteNQq^=H)m5-%2e5y9xLW4FcCOsk&Iep894Lo$n{nPQpfg8~hnG&u}1n5J= z#)ThO4>=1c9GOX&u`LXlw0#TrJZyEkadai*ZXDgRr3@Yv3Y-n}0gTmsJ}5{U6vWsw zWBW7vY7#bk$zI-6F}W7P!Ff8s_2cN;kpikIkPpT$TZNLoqg(9cen}hjdRs=H(cIw} zdc8tfFO?91jfUfer<=-;tJE}EAkRg2wVGmPv0WSd>;(667VEo+&b?fZE6#PhBLWBD_8cqRYI2w1Jp}v5_I>OWQj;iuB@mfB#{; zN25``@AF|E?oHA*$x9XYB@~c9I+Fe$S1H>6$PG%7pW@fpe%$5OFEs322{X0&2E7R!t@ zK=uWS8l_7te@Gn+G{9KKybP-I#sJggu*!Zq1N_N#b~D z7Sx3{*Tv1wqAx%E9#BL{iDD+&3<?D@tsDs z`S@XV??vMd@a@+RJM~7r)?F`FofF@&){UBmCP-9kP-kKLToR8C6DaxONH+np1SBpy zVeW*_V#4H3pqfXDLi%pg1}cc4J;!zA_+mP^l<___*~MhkMZ2*u!qB@IznE4? zlL+)4w5CrX#OUD(<*O(4b{!ljiF3K7xy~_Dg@6)LnQ!dl!I|pl!#E0wD%%$hT{p_u ztoS%@=T|BkA&+CjV4P_SJZEpQjdcCQMAiW^UpK_TP zGet4gA(WAi+pVKR?a^x-|MxvnO&<(wp;p@^By)gmmc>8CBDzl048i19OR(?7%}}iX zXuGD3{j?b^s~$rN(ej~sx0%3b#~!c|&8ry)vh#ad9DP1p)uOrB z4((9J?=c9;+teT;ogwpqY)%Fs+PdX%1W^FDNRs(IR@;GU=!_0=yh=>Q70Z$uvZrcc WNtVB8m6%xUF?zDSK0XV3q5cn6DnWPv diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill deleted file mode 100644 index 7824d11d..00000000 --- a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill +++ /dev/null @@ -1,7 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFw
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEExxb5Ill.meta deleted file mode 100644 index cb5f9024a69edc655b599987f86d7d15dbbb2ffa..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3161 zcmb^!ZEw>?xEiJH(w5SpO_~PME&D(VwVk*xv?VDDO@Kn0lq7|1(qx@|m-wh-8{fHU zkdVfgX-NJy?>|lZ4f`>B&UTWPv9S-$hve?L=lwlDPygOnm`Xlx9=M#koC$VHtIQJdZ}IB8_-!1`7+iP( zjiY(Xa~x_3=D9#K-wc2yB_rGx$Xylzc6pZu3Uxs?b9-^L+!?`YW7w=^hwcd_@h`xh z)8Lc_aA;?TTUEUOq^;@dj;bRuU|dl0lA4-cP}kLhq?smIfI`#N${uV=<#7k;xAa9E2t|JG4z3MVL!WelIz#l_Z?cX-!NLKUz_GD@X%4Cq)@S=1Nj;=EKzA(JRC_uepn4H4RPAWmz@3?$`DN(qOQ z0PMP>-H|Ujh?1M;7hE7llgkOEzJeV{O^JAI6i$b_Jz)c26wrDGm@aPKD@xS=j{IIf zbOZzM3$5z~eFf4A-$$kwx&#Nq^3KMFPOOb0*)nl~m^*Mf_LCaZO`F?`*6bF+C&l$LYLA#XdC`HRk z5;DrAf?F7p`B%u!uBGp6ZN~4Ry5U$X>=>9EV~j?$U^7B9C3QesgxZG+H;C8A%mu(V z86e|igf3Jh>oQpfAmOX*+2t2s-bdFbFB!9EQ_;-{kW*nW7kUbIK$_!#W$&XeF24I1 zLMT~L3%Zfv2cGbt(||XxN~gf@l>z56nAZ){fwH3{)11ev0K<;s4bH(D(X`=ugZSy6 zKmJ8S(|+kPOid}ur{cRPlQ8KURmOc!_D0X$Mdwn*#eG`Nw`$Li zYwb>cF}Ii_-t&+K!^Pa?v9DJej}zXN>ht<#G6t<%KO~&nwR&y8gV?FZ$QlZ$ELdVN zl0zSS9<`c>CG7#?d6kNtCpIU>21hqP`=H0GJ%LWynR81%k=c|QN3BICawni z*P!Fz{w|y@QwFfh-$z{rO)<$zd6yYkdH|CQK|yn{yPPkog*+OK=W;$2U1dA}U@uqt zR#6ZPE)rUlpaBy$!ceH5KUA5gWmZ2O2`JRLd(+NNdqF;d9>4_x}G8Lo^f`8V6dJHKD|&VYTqB$+m=oH zSYa+~KCVT9inCpw0P9{l+Aom*t3326r84CdFho7$B)^wKrBheZ$Z=!@dsRf(~E;l{COl za|VthE}!HFZRDer0FO(xm<(i zAgVqzJR1KL^XQr(2MLVtbST7)Q0@VJEFk5AxDm}8u&fz!v)~47A#ib+slpxTqxmEG z+e)$omVuRMS|%N!o!{x==<~^17fr=>Xon(x2h-4aohoDq)~6l-8>1-*dnRE4tWX?a wvqmz+hjK-L6+WQ2567#9MFUAPCnxQh+**=FF -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAK2l2bzovL29yZy5nYXZvLmRjL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAMR0FWTyBEQyBTSUEyAAAAJwBHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAUwBJAEEAUAAgAFYAZQByAHMAaQBvAG4AIAAyACAAUwBlAHIAdgBpAGMAZQAAAAAAAADIAFQAaABlACAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAnAHMAIABzAGkAdABlAHcAaQBkAGUAIABTAEkAQQBQACAAdgBlAHIAcwBpAG8AbgAgADIAIABzAGUAcgB2AGkAYwBlAAoAcAB1AGIAbABpAHMAaABlAHMAIABhAGwAbAAgAHQAaABlACAAaQBtAGEAZwBlAHMAIABwAHUAYgBsAGkAcwBoAGUAZAAgAHQAaAByAG8AdQBnAGgAIAB0AGgAZQAgAHMAaQB0AGUALgAgAEYAbwByACAAbQBvAHIAZQAgAGEAZAB2AGEAbgBjAGUAZAAKAHEAdQBlAHIAaQBlAHMAIABpAG4AYwBsAHUAZABpAG4AZwAgAHUAcABsAG8AYQBkAHMALAAgAGEAbABsACAAdABoAGkAcwAgAGQAYQB0AGEAIABpAHMAIABhAGwAcwBvACAAYQB2AGEAaQBsAGEAYgBsAGUAIAB0AGgAcgBvAHUAZwBoAAoATwBiAHMAVABBAFAALgAAAD5odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDE2LTA4LTE2VDEyOjQwOjAwAAAAEzIwMjQtMDItMDdUMTI6NDE6MzIAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAHBaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL29ic2NvcmUvZGwvZGxtZXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvX19zeXN0ZW1fXy9zaWFwMi9zaXRld2lkZS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vc2lhcDIvc2l0ZXdpZGUvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3NpYXAyL3NpdGV3aWRlL3NpYXAyLnhtbD8AAAEQaXZvOi8vaXZvYS5uZXQvc3RkL2RhdGFsaW5rI2xpbmtzLTEuMTo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC90YXAjYXV4Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjdGFibGVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3Zvc2kjYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NpYSNxdWVyeS0yLjAAAACTdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwAAAAXXN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZDo6OnB5IFZPIHNlcDo6OnN0ZAAAAEs6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjoAAAAVaXZvOi8vb3JnLmdhdm8uZGMvdGFwAAAAEXZzOmNhdGFsb2dzZXJ2aWNlAAAAC0dBVk8gREMgVEFQAAAAHABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACAAVABBAFAAIABzAGUAcgB2AGkAYwBlAAAAAAAAFBkAVABoAGUAIABHAEEAVgBPACAARABhAHQAYQAgAEMAZQBuAHQAZQByACcAcwAgAFQAQQBQACAAZQBuAGQAIABwAG8AaQBuAHQALgAgACAACgBUAGgAZQAgAFQAYQBiAGwAZQAgAEEAYwBjAGUAcwBzACAAUAByAG8AdABvAGMAbwBsACAAKABUAEEAUAApACAAbABlAHQAcwAgAHkAbwB1ACAAZQB4AGUAYwB1AHQAZQAgAHEAdQBlAHIAaQBlAHMAIABhAGcAYQBpAG4AcwB0ACAAbwB1AHIACgBkAGEAdABhAGIAYQBzAGUAIAB0AGEAYgBsAGUAcwAsACAAaQBuAHMAcABlAGMAdAAgAHYAYQByAGkAbwB1AHMAIABtAGUAdABhAGQAYQB0AGEALAAgAGEAbgBkACAAdQBwAGwAbwBhAGQAIAB5AG8AdQByACAAbwB3AG4ACgBkAGEAdABhAC4AIAAgAAoACgBJAG4AIABHAEEAVgBPACcAcwAgAGQAYQB0AGEAIABjAGUAbgB0AGUAcgAsACAAdwBlACAAaQBuACAAcABhAHIAdABpAGMAdQBsAGEAcgAgAGgAbwBsAGQAIABzAGUAdgBlAHIAYQBsACAAbABhAHIAZwBlAAoAYwBhAHQAYQBsAG8AZwBzACAAbABpAGsAZQAgAFAAUABNAFgATAAsACAAMgBNAEEAUwBTACAAUABTAEMALAAgAFUAUwBOAE8ALQBCADIALAAgAFUAQwBBAEMANAAsACAAVwBJAFMARQAsACAAUwBEAFMAUwAgAEQAUgAxADYALAAKAEgAUwBPAFkALAAgAGEAbgBkACAAcwBlAHYAZQByAGEAbAAgAEcAYQBpAGEAIABkAGEAdABhACAAcgBlAGwAZQBhAHMAZQBzACAAYQBuAGQAIABhAG4AYwBpAGwAbABhAHIAeQAgAHIAZQBzAG8AdQByAGMAZQBzACAAZgBvAHIACgB5AG8AdQAgAHQAbwAgAHUAcwBlACAAaQBuACAAYwByAG8AcwBzAG0AYQB0AGMAaABlAHMALAAgAHAAbwBzAHMAaQBiAGwAeQAgAHcAaQB0AGgAIAB1AHAAbABvAGEAZABlAGQAIAB0AGEAYgBsAGUAcwAuAAoACgBUAGEAYgBsAGUAcwAgAGUAeABwAG8AcwBlAGQAIAB0AGgAcgBvAHUAZwBoACAAdABoAGkAcwAgAGUAbgBkAHAAbwBpAG4AdAAgAGkAbgBjAGwAdQBkAGUAOgAgAG4AdQBjAGEAbgBkACAAZgByAG8AbQAgAHQAaABlACAAYQBtAGEAbgBkAGEAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAbgBuAGkAcwByAGUAZAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAYQBuAHQAYQByAGUAcwAxADAAIABzAGMAaABlAG0AYQAsACAAZAByADEAMAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABmAHIAYQBtAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcABvACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHAAcABsAGEAdQBzAGUAIABzAGMAaABlAG0AYQAsACAAZwBmAGgALAAgAGkAZAAsACAAaQBkAGUAbgB0AGkAZgBpAGUAZAAsACAAbQBhAHMAdABlAHIALAAgAG4AaQBkACwAIAB1AG4AaQBkAGUAbgB0AGkAZgBpAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAGEAcgBpAGcAZgBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABhAHIAaQBoAGkAcAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAYQB1AGcAZQByACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHAAaABvAHQAXwBhAGwAbAAsACAAcwBzAGEAXwB0AGkAbQBlAF8AcwBlAHIAaQBlAHMAIABmAHIAbwBtACAAdABoAGUAIABiAGcAZABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABiAG8AeQBkAGUAbgBkAGUAIABzAGMAaABlAG0AYQAsACAAYwBhAHQAIABmAHIAbwBtACAAdABoAGUAIABiAHIAbwB3AG4AZAB3AGEAcgBmAHMAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABmAGwAdQB4AHAAbwBzAHYAMQAyADAAMAAsACAAZgBsAHUAeABwAG8AcwB2ADUAMAAwACwAIABmAGwAdQB4AHYAMQAyADAAMAAsACAAZgBsAHUAeAB2ADUAMAAwACwAIABvAGIAagBlAGMAdABzACwAIABzAHAAZQBjAHQAcgBhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAGwAaQBmAGEAZAByADMAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHMAcgBjAGMAYQB0ACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwAgAHMAYwBoAGUAbQBhACwAIABtAGUAdABhACAAZgByAG8AbQAgAHQAaABlACAAYwBhAHIAcwBhAHIAYwBzACAAcwBjAGgAZQBtAGEALAAgAGwAaQBuAGUAXwB0AGEAcAAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAYQBzAGEAXwBsAGkAbgBlAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAbgBzADUAdQBwAGQAYQB0AGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwA4ADIAbQBvAHIAcABoAG8AegAgAHMAYwBoAGUAbQBhACwAIABnAGUAbwAgAGYAcgBvAG0AIAB0AGgAZQAgAGMAcwB0AGwAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAYQBuAGkAcwBoACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHAAbABhAHQAZQBzACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AF8AcwBwAGUAYwB0AHIAYQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABkAGYAYgBzAHMAcABlAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGQAbQB1AGIAaQBuACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABlAG0AaQAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAZgBlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGYAawA2AGoAbwBpAG4ALAAgAHAAYQByAHQAMQAsACAAcABhAHIAdAAzACAAZgByAG8AbQAgAHQAaABlACAAZgBrADYAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGYAbABhAHIAZQBfAHMAdQByAHYAZQB5ACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAG8AcgBkAGUAcgBzAG0AZQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAGwAYQBzAGgAaABlAHIAbwBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABmAG8AcgBuAGEAeAAgAHMAYwBoAGUAbQBhACwAIABkAHIAMgBfAHQAcwBfAHMAcwBhACwAIABkAHIAMgBlAHAAbwBjAGgAZgBsAHUAeAAsACAAZAByADIAbABpAGcAaAB0ACwAIABkAHIAMwBsAGkAdABlACwAIABlAGQAcgAzAGwAaQB0AGUAIABmAHIAbwBtACAAdABoAGUAIABnAGEAaQBhACAAcwBjAGgAZQBtAGEALAAgAGgAeQBhAGMAbwBiACwAIABtAGEAZwBsAGkAbQBzADUALAAgAG0AYQBnAGwAaQBtAHMANgAsACAAbQBhAGcAbABpAG0AcwA3ACwAIABtAGEAaQBuACwAIABtAGkAcwBzAGkAbgBnAF8AMQAwAG0AYQBzACwAIAByAGUAagBlAGMAdABlAGQALAAgAHIAZQBzAG8AbAB2AGUAZABzAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGMAbgBzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABnAGMAcABtAHMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAYQBwACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGQAcgAyAGQAaQBzAHQAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcABoAG8AdABvAG0AZQB0AHIAeQAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZAByADIAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABzAHAAZQBjAHQAcgBhACwAIABzAHMAYQBtAGUAdABhACwAIAB3AGkAdABoAHAAbwBzACAAZgByAG8AbQAgAHQAaABlACAAZwBkAHIAMwBzAHAAZQBjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAYQB1AHQAbwAgAHMAYwBoAGUAbQBhACwAIABsAGkAdABlAHcAaQB0AGgAZABpAHMAdAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAZQBkAHIAMwBkAGkAcwB0ACAAcwBjAGgAZQBtAGEALAAgAGcAZQBuAGUAcgBhAHQAZQBkAF8AZABhAHQAYQAsACAAbQBhAGcAbABpAG0AXwA1ACwAIABtAGEAZwBsAGkAbQBfADYALAAgAG0AYQBnAGwAaQBtAF8ANwAsACAAbQBhAGkAbgAsACAAcABhAHIAcwBlAGMAXwBwAHIAbwBwAHMAIABmAHIAbwBtACAAdABoAGUAIABnAGUAZAByADMAbQBvAGMAawAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBlAGQAcgAzAHMAcAB1AHIAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAcwBlAHIAdgBpAGMAZQBzACwAIAB0AGEAYgBsAGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGcAbABvAHQAcwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAZwBwAHMAMQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAaABkAGcAYQBpAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBpAGMAbwB1AG4AdABlAHIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAaQBwAHAAYQByAGMAbwBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABoAHAAcAB1AG4AaQBvAG4AIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAGgAcwBvAHkAIABzAGMAaABlAG0AYQAsACAAbgB1AGMAYQBuAGQAIABmAHIAbwBtACAAdABoAGUAIABpAGMAZQBjAHUAYgBlACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABpAG4AZgBsAGkAZwBoAHQAIABzAGMAaABlAG0AYQAsACAAbwBiAHMAXwByAGEAZABpAG8ALAAgAG8AYgBzAGMAbwByAGUAIABmAHIAbwBtACAAdABoAGUAIABpAHYAbwBhACAAcwBjAGgAZQBtAGEALAAgAGUAdgBlAG4AdABzACwAIABwAGgAbwB0AHAAbwBpAG4AdABzACwAIAB0AGkAbQBlAHMAZQByAGkAZQBzACAAZgByAG8AbQAgAHQAaABlACAAawAyAGMAOQB2AHMAdAAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAGsAYQBwAHQAZQB5AG4AIABzAGMAaABlAG0AYQAsACAAawBhAHQAawBhAHQAIABmAHIAbwBtACAAdABoAGUAIABrAGEAdABrAGEAdAAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANQAgAHMAYwBoAGUAbQBhACwAIABzAHMAYQBfAGwAcgBzACwAIABzAHMAYQBfAG0AcgBzACAAZgByAG8AbQAgAHQAaABlACAAbABhAG0AbwBzAHQANgAgAHMAYwBoAGUAbQBhACwAIABkAGkAcwBrAF8AYgBhAHMAaQBjACwAIABoAF8AbABpAG4AawAsACAAaQBkAGUAbgB0ACwAIABtAGUAcwBfAGIAaQBuAGEAcgB5ACwAIABtAGUAcwBfAG0AYQBzAHMAXwBwAGwALAAgAG0AZQBzAF8AbQBhAHMAcwBfAHMAdAAsACAAbQBlAHMAXwByAGEAZABpAHUAcwBfAHMAdAAsACAAbQBlAHMAXwBzAGUAcABfAGEAbgBnACwAIABtAGUAcwBfAHQAZQBmAGYAXwBzAHQALAAgAG8AYgBqAGUAYwB0ACwAIABwAGwAYQBuAGUAdABfAGIAYQBzAGkAYwAsACAAcAByAG8AdgBpAGQAZQByACwAIABzAG8AdQByAGMAZQAsACAAcwB0AGEAcgBfAGIAYQBzAGkAYwAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAaQBmAGUAXwB0AGQAIABzAGMAaABlAG0AYQAsACAAZwBlAG8AYwBvAHUAbgB0AHMALAAgAG0AZQBhAHMAdQByAGUAbQBlAG4AdABzACwAIABzAHQAYQB0AGkAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIABsAGkAZwBoAHQAbQBlAHQAZQByACAAcwBjAGgAZQBtAGEALAAgAHIAYQB3AGYAcgBhAG0AZQBzACAAZgByAG8AbQAgAHQAaABlACAAbABpAHYAZQByAHAAbwBvAGwAIABzAGMAaABlAG0AYQAsACAAcgBtAHQAYQBiAGwAZQAsACAAcwBwAGUAYwB0AHIAYQAsACAAcwBzAGEAbQBlAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAbwB0AHMAcwBwAG8AbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAbABzAHAAbQAgAHMAYwBoAGUAbQBhACwAIABwAGwAYQB0AGUAcwAsACAAdwBvAGwAZgBwAGEAbABpAHMAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAGwAcwB3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABtAGEAZwBpAGMAIABzAGMAaABlAG0AYQAsACAAcgBlAGQAdQBjAGUAZAAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AYQBpAGQAYQBuAGEAawAgAHMAYwBoAGUAbQBhACwAIABlAHgAdABzACAAZgByAG8AbQAgAHQAaABlACAAbQBjAGUAeAB0AGkAbgBjAHQAIABzAGMAaABlAG0AYQAsACAAYwB1AGIAZQBzACwAIABzAGwAaQB0AHMAcABlAGMAdAByAGEAIABmAHIAbwBtACAAdABoAGUAIABtAGwAcQBzAG8AIABzAGMAaABlAG0AYQAsACAAZQBwAG4AXwBjAG8AcgBlACwAIABtAHAAYwBvAHIAYgAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AcABjACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHMAdABhAHIAcwAgAGYAcgBvAG0AIAB0AGgAZQAgAG0AdwBzAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAsACAAcwB0AGEAcgBzACAAZgByAG8AbQAgAHQAaABlACAAbQB3AHMAYwBlADEANABhACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABvAGIAcwBjAG8AZABlACAAcwBjAGgAZQBtAGEALAAgAGIAaQBiAHIAZQBmAHMALAAgAG0AYQBwAHMALAAgAG0AYQBzAGUAcgBzACwAIABtAG8AbgBpAHQAbwByACAAZgByAG8AbQAgAHQAaABlACAAbwBoAG0AYQBzAGUAcgAgAHMAYwBoAGUAbQBhACwAIABtAGUAYQBzAHUAcgBlAG0AZQBuAHQAcwAsACAAcwBzAGEAIABmAHIAbwBtACAAdABoAGUAIABvAG4AZQBiAGkAZwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEALAAgAHMAaABhAHAAZQBzACAAZgByAG8AbQAgAHQAaABlACAAbwBwAGUAbgBuAGcAYwAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcABjAGMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAbABjACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAyACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAYwAzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAGwAdABzACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAG8AbABjAGEAdABzAG0AYwAgAHMAYwBoAGUAbQBhACwAIABjAHUAYgBlAHMALAAgAG0AYQBwAHMAIABmAHIAbwBtACAAdABoAGUAIABwAHAAYQBrAG0AMwAxACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIABwAHAAbQB4ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4ALAAgAHUAcwBuAG8AYwBvAHIAcgAgAGYAcgBvAG0AIAB0AGgAZQAgAHAAcABtAHgAbAAgAHMAYwBoAGUAbQBhACwAIABtAGEAcAAxADAALAAgAG0AYQBwADYALAAgAG0AYQBwADcALAAgAG0AYQBwADgALAAgAG0AYQBwADkALAAgAG0AYQBwAF8AdQBuAGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcAByAGQAdQBzAHQAIABzAGMAaABlAG0AYQAsACAAZAByADIALAAgAGQAcgAzACwAIABkAHIANAAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHIAYQB2AGUAIABzAGMAaABlAG0AYQAsACAAaQBtAGEAZwBlAHMALAAgAHAAaABvAHQAbwBuAHMAIABmAHIAbwBtACAAdABoAGUAIAByAG8AcwBhAHQAIABzAGMAaABlAG0AYQAsACAAYQBsAHQAXwBpAGQAZQBuAHQAaQBmAGkAZQByACwAIABhAHUAdABoAG8AcgBpAHQAaQBlAHMALAAgAGMAYQBwAGEAYgBpAGwAaQB0AHkALAAgAGcAXwBuAHUAbQBfAHMAdABhAHQALAAgAGkAbgB0AGUAcgBmAGEAYwBlACwAIABpAG4AdABmAF8AcABhAHIAYQBtACwAIAByAGUAZwBpAHMAdAByAGkAZQBzACwAIAByAGUAbABhAHQAaQBvAG4AcwBoAGkAcAAsACAAcgBlAHMAXwBkAGEAdABlACwAIAByAGUAcwBfAGQAZQB0AGEAaQBsACwAIAByAGUAcwBfAHIAbwBsAGUALAAgAHIAZQBzAF8AcwBjAGgAZQBtAGEALAAgAHIAZQBzAF8AcwB1AGIAagBlAGMAdAAsACAAcgBlAHMAXwB0AGEAYgBsAGUALAAgAHIAZQBzAG8AdQByAGMAZQAsACAAcwB0AGMAXwBzAHAAYQB0AGkAYQBsACwAIABzAHQAYwBfAHMAcABlAGMAdAByAGEAbAAsACAAcwB0AGMAXwB0AGUAbQBwAG8AcgBhAGwALAAgAHMAdQBiAGoAZQBjAHQAXwB1AGEAdAAsACAAdABhAGIAbABlAF8AYwBvAGwAdQBtAG4ALAAgAHQAYQBwAF8AdABhAGIAbABlACwAIAB2AGEAbABpAGQAYQB0AGkAbwBuACAAZgByAG8AbQAgAHQAaABlACAAcgByACAAcwBjAGgAZQBtAGEALAAgAG8AYgBqAGUAYwB0AHMALAAgAHAAaABvAHQAcABhAHIAIABmAHIAbwBtACAAdABoAGUAIABzAGEAcwBtAGkAcgBhAGwAYQAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAcwBkAHMAcwBkAHIAMQA2ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAGQAcwBzAGQAcgA3ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAG0AYQBrAGMAZQBkACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAZQBjAGkAZQBzACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIABzAHAAbQA0ACAAcwBjAGgAZQBtAGEALAAgAHMAbwB1AHIAYwBlAHMAIABmAHIAbwBtACAAdABoAGUAIABzAHUAcABlAHIAYwBvAHMAbQBvAHMAIABzAGMAaABlAG0AYQAsACAAYwBvAGwAdQBtAG4AcwAsACAAZwByAG8AdQBwAHMALAAgAGsAZQB5AF8AYwBvAGwAdQBtAG4AcwAsACAAawBlAHkAcwAsACAAcwBjAGgAZQBtAGEAcwAsACAAdABhAGIAbABlAHMAIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcABfAHMAYwBoAGUAbQBhACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGEAcAB0AGUAcwB0ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB0AGUAbgBwAGMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAZwBhAHMAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAgAGYAcgBvAG0AIAB0AGgAZQAgAHQAaABlAG8AcwBzAGEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAbABpAG4AZQBfAHQAYQBwACAAZgByAG8AbQAgAHQAaABlACAAdABvAHMAcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAdAB3AG8AbQBhAHMAcwAgAHMAYwBoAGUAbQBhACwAIABpAGMAcgBzAGMAbwByAHIALAAgAG0AYQBpAG4ALAAgAHAAcABtAHgAbABjAHIAbwBzAHMAIABmAHIAbwBtACAAdABoAGUAIAB1AGMAYQBjADMAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHUAYwBhAGMANAAgAHMAYwBoAGUAbQBhACwAIABtAGEAaQBuACAAZgByAG8AbQAgAHQAaABlACAAdQBjAGEAYwA1ACAAcwBjAGgAZQBtAGEALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB1AHIAYQB0ADEAIABzAGMAaABlAG0AYQAsACAAZABhAHQAYQAsACAAcABsAGEAdABlAGMAbwByAHIAcwAsACAAcABsAGEAdABlAHMALAAgAHAAcABtAHgAYwByAG8AcwBzACwAIABzAHAAdQByAGkAbwB1AHMALAAgAHQAdwBvAG0AYQBzAHMAYwByAG8AcwBzACAAZgByAG8AbQAgAHQAaABlACAAdQBzAG4AbwBiACAAcwBjAGgAZQBtAGEALAAgAGQAYQB0AGEAIABmAHIAbwBtACAAdABoAGUAIAB2AGUAcgBvAG4AcQBzAG8AcwAgAHMAYwBoAGUAbQBhACwAIABzAHQAcgBpAHAAZQA4ADIAIABmAHIAbwBtACAAdABoAGUAIAB2AGwAYQBzAHQAcgBpAHAAZQA4ADIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAZABzAGQAcwBzADEAMAAgAHMAYwBoAGUAbQBhACwAIABhAHIAYwBoAGkAdgBlAHMALAAgAG0AYQBpAG4AIABmAHIAbwBtACAAdABoAGUAIAB3AGYAcABkAGIAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHcAaQBzAGUAIABzAGMAaABlAG0AYQAsACAAbQBhAGkAbgAgAGYAcgBvAG0AIAB0AGgAZQAgAHgAcABwAGEAcgBhAG0AcwAgAHMAYwBoAGUAbQBhACwAIABkAGEAdABhACAAZgByAG8AbQAgAHQAaABlACAAegBjAG8AcwBtAG8AcwAgAHMAYwBoAGUAbQBhAC4AAAA3aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vaW5mbwAAABAARwBBAFYATwAgAEQAYQB0AGEAIABDAGUAbgB0AGUAcgAAABMyMDA5LTEyLTAxVDEwOjAwOjAwAAAAEzIwMjQtMDItMDZUMTA6MTk6MzMAAAAAAAAAAAAAAAAAAAAAf8AAAAAAAAAAAAFYaHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vZXhhbXBsZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL19fc3lzdGVtX18vdGFwL3J1bi90YWJsZU1ldGFkYXRhOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vY2FwYWJpbGl0aWVzOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9fX3N5c3RlbV9fL3RhcC9ydW4vYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXAAAADYaXZvOi8vaXZvYS5uZXQvc3RkL2RhbGkjZXhhbXBsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSN0YWJsZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNjYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdm9zaSNhdmFpbGFiaWxpdHk6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwAAAAeXZyOndlYmJyb3dzZXI6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHA6OjpweSBWTyBzZXA6Ojp2czpwYXJhbWh0dHAAAABIOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkOjo6cHkgVk8gc2VwOjo6c3RkAAAAPDo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Og==
\ No newline at end of file diff --git a/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta b/pyvo/discover/tests/data/servedby-elision-responses/POST-reg.g-vo.org-sync-zBFGPNaEhyZcmD9E.meta deleted file mode 100644 index f4dc32860a4ba98138dccb0ade9e7a3d307219e8..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2916 zcmds3NpIUm6gC<=cH=aT8?->t1W*qS>@cEiIZGWN2UV7{DUu`0NpmO$L-I*vOp(mY zP_haHXf8z!@K*Ns^x7ZMAJcD0N^)|@;$sB?ocHE!^Y-87|9ZJRm;K(P>&dcIT*Z>v zp+o7Df09L)xI;pw$rVAbW0FdmQi<4Bu^^4Db4iZ^NrCi~H>6$9R_UMV#@qBwnw)1+ zg@V##*$#c5Y~_Ukc$V7&BFUN1cA$4v2_DEEi82My?FIcbS?x}6jVW%?cH`iPob-2y zmn4QHa5yLq*LHdR;X$Qp?wHk*8hKKY^Mb5Ob<^B7H#N_^!xapg-_1VPo`%8AQuR)0 zkE~L4vwEwvxpQyp_Ptx%r3X*Dn*O3428sezR^teK7wZMs&A{(?6#1Ub^}{O1a8GXyTRqYWk?T?{1 zsBD{CTZq7V(+lF`4eiGjZrc>8Q_)?i<(OG)SNp$u(an-WJs;7zS+a!YJfCyokTc*l zH!3&u%>~3J$g>InA~OSyh@vw0k&v43(j0L_B? z(B}Ji*-7&CyY~@Cl(ZfN=?nl}tRXRTT{&;*%o4f-tIP$(AgK?Y?vp7JxGNI>S(ko*as zL(&#rq?<>MLi{Q$i$8KkSrc#XS~xe@KSVffriX@zrR-fvEHsV8wd3Uj=C}> z5+FBst$H{6?`U26v|Y>p(b#z2HY7z;OipLi4vd+I>mGBt~MVRN#*%fLDpQaFfgT0rIXHxr~9Eo`Db=pty5dt$W&p<$}TKBM1 zYZ}eQUe{2ODdB~Ot)SPJiR-HLE4J- z<**{q2y%M8x=9Pv-S#0NLsFCQZJaZ8*tX z>c(!Y(zlo&>~(GsQ{I3=AX}5Ufo|w{0(*r7ZjohUZ>)!^?t{b!I4&@ogl1XNv*}pR X`D|xOR+x=_7#+J - The Bochum Galactic Disk Survey is an ongoing project to monitor the -stellar content of the Galactic disk in a 6 degree wide stripe -centered on the Galactic plane. The data has been recorded since -mid-2010 in Sloan r and i simultaneously with the RoBoTT Telecsope at -the Universitaetssternwarte Bochum near Cerro Armazones in the Chilean -Atacama desert. It contains measurements of about 2x10^7 stars over -more than seven years. Additionally, intermittent measurements in -Johnson UVB and Sloan z have been recorded as well.{'siaarea0': <pgsphere PositionInterval Unknown 115.9428322966 -29.05 -116.0571677034 -28.95>, '_ra': 116.0, '_dec': -29.0, '_sra': 0.1, -'_sdec': 0.1, 'format0': frozenset({'image/jpeg', -'application/x-votable+xml;content=datalink', 'image/fits'})}Written by DaCHS 2.9.2 SIAPRendererSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceA bibliographic source citable for (parts of) this dataOriginating VO resourceData centre that has delivered the dataLegal conditions applicable to (parts of) the data containedContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceName of a person or entity that produced a contributing resourceAccess key for the dataMIME type of the file servedSize of the data in bytesApproximate center of image, RAApproximate center of image, DecSynthetic name of the imageIdentifier of the originating instrumentEpoch at midpoint of observationNumber of axes in dataNumber of pixels along each of the axesThe pixel scale on each image axisCoordinate system reference frameEquinox of the given coordinatesFITS WCS projection typeWCS reference pixelWorld coordinates at WCS reference pixelFITS WCS CDij matrixFreeform name of the bandpass usedUnit of bandpass specifications (always m).Characteristic quantity for the bandpass of the imageUpper limit of the bandpass (in BandPass_Unit units)Lower limit of the bandpass (in BandPass_Unit units)Flags specifying the processing done (C-original; F-resampled; Z-fluxes valid; X-not resampled; V-for display onlyField covered by the imageSurvey field observed.Effective exposure time (sum of exposure times of all images contributing here).Dataset identifier assigned by the publisherAAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBiJAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA2jAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCzWgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfrgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBe+gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEOgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCBFAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDElAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHvgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjMxOjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH42BtOgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB3PAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHaAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+FwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD+DwEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgCAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjI3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJyiUsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjIyOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5ICp6IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA9ZwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjA4OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpDLqYcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBT5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAzOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpMZaQ4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEWfgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDInwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAAaAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/5BgEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/98gEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2CQEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDxOgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjQyOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP518xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDzKQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjQ1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf7BCwAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yOTU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/k/AEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAzOjIwOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpHVheEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI5NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDPegEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIxVDA0OjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXMCp8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDTKwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjEzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaPXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC95gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjI0OjU3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI3wEkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjuQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjMwOjA3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIA1X/PcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBm4wEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIxVDA0OjA1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpXKJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjMxOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLC8HMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwBwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCrngEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB96gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWhgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFeQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCRxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCOnQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCenAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1dgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1egEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/2vQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUkwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqNgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCN6QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6DAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCiTQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAsAAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjEzOjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhaN18wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjBQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjI0OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaI2O+wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKDwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjU4OjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUwi5EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkEwEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjMzOjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL9uXUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjMyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLmlvIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBeoAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjM3OjE0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSrAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBd7AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRRAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB2tQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/BIAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE2VDA1OjM1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxe53KJSsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTEzVDA4OjQwOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxei5FyKEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB7+wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjUxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BSKzxMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBGBAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAzVDA1OjU3OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw65/Q+MsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSfwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjQwOjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x5FBnMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBxQgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjE5OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BG8feoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0PwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjIzOjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5py7u7wAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBkbQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjI5OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw450/ty8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBlqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjMwOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4x1h2VEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB6OQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjE2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CFvH3sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBVIgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjM4OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw354br5kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDHkQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjU4OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRUyD+4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAH9wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE1VDAzOjQzOjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxexPdG7AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBb/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjMxOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuII17o3YAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBBGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjM0OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ3EE7kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhcAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjM5OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY40t5AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCt5wEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjM0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJMJe0IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCoGgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjMzOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBL/PdIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCREwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjMyOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxLnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCebwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjM3OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpNQBhEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCI/QEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjQwOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhj25dUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCpQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjU2OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZUE7i0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDK6AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjUzOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRTIP7cAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgNQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjMwOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHo1niawAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBHxgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjMxOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qLDsqIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDOmQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjE4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJcAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDeawEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTA4VDA0OjA1OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBXRWeIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTE0VDA3OjAxOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6V5vgIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfVAEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjUzOjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4oNp0EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBTMwEBdAji24O6JwD36IFAGIzoAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAyOjA4OjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAt18xsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCLGQEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjUxOjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgSOmfsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAji3BK/6wD36IFAZNRQAAAAwQkdEUyBHRFNfMDc0NC0yOTU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjUwOjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoR9J9IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDWKAEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI0VDAyOjA3OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4tKVbYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDWQEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTAzLTI1VDAyOjIyOjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAyyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDsqAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE0VDAxOjA2OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgXx96gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZUgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE2LTA0LTE1VDAxOjA1OjI4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoXRuvoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBLSgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI0VDAyOjE3OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4xD4y0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUbgEBdAji24O6JwD36IFAGIzoAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTAzLTI1VDAyOjM1OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQA3KhkIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A9+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n3dSJ/APytHpp2YiEBdWcpwHfnAwDzFNLm44rBAXKqiyaFExcA8xTS5uOKwQFyofrvh9b/APytHpp2YiAAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBR+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE0VDAxOjIwOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgclKtsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yOTU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBUyAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgeiAyMDE2LTA0LTE1VDAxOjE3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSobksX4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI5NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjUxOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x9AGEYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBsKQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjQwOjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p5AeV0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBjMgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjQxOjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h5T0PkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCByAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAzVDA2OjAwOjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3aAQTuMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9WEwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDUwAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDIGAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAxLTEzVDA3OjA0OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryWwWwYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB+cQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE3VDA2OjU5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfCVA2nQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcxMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAKxwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTEyLTE5VDA4OjIzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOxfSy3LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzEyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC1HAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjE5OjA2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBGyoZAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5IDCLkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yOTU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKNAEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjI3OjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxJy6mIAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI5NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBecwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjUzOjMxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R9sd9kAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBc3gEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjQyOjM2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J50DacAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBdvwEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjQzOjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B6MU3AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+d+AEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAyLTIxVDAyOjA1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQshX/QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yOTU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB/UgEBdAji3BK/6wD36IFAZNRQAAAAtQkdEUyBHRFNfMDc0NC0yOTU4IFNEU1MgaSAyMDEyLTAxLTEyVDA3OjA2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSXj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A9+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1b7n4BTOnAPytHprFLu0BdWcpwQfmiwDzFNLnLTFZAXKqiycTHnMA8xTS5y0xWQFyofrwFdFXAPytHprFLuwAAAA1HRFNfMDc0NC0yOTU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI5NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZAAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE0VDAzOjI1OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI5pbwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIzVDAzOjE1OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FaQ4IAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDEZwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIxVDAzOjU3OjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUi5FAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDRDwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTIwVDA0OjA2OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXnWSAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCsrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE5VDA2OjE3OjMwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC9uQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE4VDAzOjUwOjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRSBU9EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCkPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE3VDAzOjI2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwJJXOskAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaZAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE2VDAzOjI2OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJQZykAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCHlQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCQuQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC+bQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCKCwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3OAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5hQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo0gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCwMAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4qAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB5WAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBAU+QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTE2VDA2OjU1OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTj71AAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCS1QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB4HQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB0EgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCqYwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE3L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBA6wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDC0gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNS9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/n+QEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE1LTAzLTIwVDAyOjQ2OjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7UAYQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE1L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgYgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZLQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCE8gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB11AEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDMfQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI0VDAxOjMxOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4goM5QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCaCgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDZrAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDN5QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBORwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBNDAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBRngEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBSJQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbSQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBMKwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNi9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBL0QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE2L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA9IAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBZ4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAzVDAyOjI0OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQl7QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBifgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcKgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMzI5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfgQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAzLTMwVDAyOjIzOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuHoy/hqMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAzMjkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBJiAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEzL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L0Jfai9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gQiAyMDE1LTAzLTIwVDAyOjMyOjMzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho2PXCkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gQgAAAAFtPp2YUoLq56Y+onR2ymG4gj6Y1I01iCIjAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvQl9qL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMi9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDA4wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEyL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMTI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCWswEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTAxLTI1VDA2OjIzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOt/qIWYFUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAxMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwMzMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC66QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAxVDAyOjI0OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuH4zY77EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzAzMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAyVDAyOjIyOjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIAyts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDDLAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTAzVDAyOjI0OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIIzQNp0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCXlAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA0VDAyOjI3OjEwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIQ0U2/gAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMy9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTMwNDA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDCSwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDEzLTA0LTA1VDAyOjMxOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuIY1+rC8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDEzL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMzA0MDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCx8gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE1LTAzLTIwVDAzOjAxOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvhpAgPK4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDjKgEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxMS9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDnjwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDExLTA0LTMwVDIzOjM0OjE4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP23LqYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDExL0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBABdgEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTIxVDAxOjQ4OjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwPgmavN8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/7fAEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI0VDAxOjE3OjQzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4bofGYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/6QQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTAzLTI1VDAxOjMzOjI5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAhPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBACKgEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE0VDAwOjEyOjIzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgEZyiUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Vfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA/9mAEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gVSAyMDE2LTA0LTE1VDAwOjEyOjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoEkycQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVQAAAAFtPpc4PBfEfgU+miwmI6sq5z6UIfX0DYN2AAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVV9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDS0QEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI0VDAxOjQyOjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4kjRWgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDKYQEBdAjisk72GwDv6IFAGKKAAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTAzLTI1VDAxOjU4OjQ1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAqOOOQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBEJTwEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE0VDAwOjQwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgOcQTwAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L1Zfai9lcTAzMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBD49gEBdAjist373wDv6IFAZOnkAAAAwQkdEUyBHRFNfMDc0NC0yNzU4IEpvaG5zb24gViAyMDE2LTA0LTE1VDAwOjM5OjM5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoOGQf4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAACUpvaG5zb24gVgAAAAFtPqJ0dsphuII+qH6m+f9f8j6gGysppGkrAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvVl9qL2VxMDMwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBwuwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI0VDAxOjMxOjQ3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwP4golKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwMzI0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBo/wEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTAzLTI1VDAxOjQ3OjQwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwQAmSA8sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjAzMjQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBunwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE0VDAwOjI3OjUzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSgJ6gDEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTYwNDE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1pwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE2LTA0LTE1VDAwOjI4OjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOwSoJ96gEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE2L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNjA0MTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBfJwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAxLTMxVDA1OjM3OjA5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3B34CRoAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMTMxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAxVDA1OjM2OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3J3g5pcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAxMzEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBf2wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAyVDA1OjQ3OjAwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3R7YLYMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCCTwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTAzVDA1OjU0OjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3Z98ZaQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBpWQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA0VDA1OjM0OjQyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3h3ASNEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBtvgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA1VDA1OjMzOjQ5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3p2sLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCEawEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA2VDA1OjQ1OjA4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw3x6ts2QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA2LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWtwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA3VDA1OjMyOjEzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw352HxloAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDYuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB38AEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTA4VDA2OjA5OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4CDcWYEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBg6QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE0VDA1OjIzOjU2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw4xzLSHAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE0LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmtgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE1VDA1OjIyOjM0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw45ysLwcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTQuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBIpwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTE2VDA2OjU1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5CTlEpUAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBx9gEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTIxVDA1OjE2OjUwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw5pwpt/EAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBByIwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMLUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMLQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBhQwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBgvAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNS9HRFNfMDc0NC0yNzU4L3pfcy9lcTAzMDAwMG1zLzIwMTUwMzE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBA4IQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgeiAyMDE1LTAzLTIwVDAyOjQ2OjQ4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOvho7ToG0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgegAAAAFtPq3dCrKLgwA+sitzF8cTcj6qtZaC7GGbAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QfAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE1L0dEU18wNzQ0LTI3NTgvel9zL2VxMDMwMDAwbXMvMjAxNTAzMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMTExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB1IAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAxLTEyVDA2OjU4OjUyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtQSU7izAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAxMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMi9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTIwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzA+VLgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDEyLTAyLTIxVDAxOjU3OjU0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOtVQp64UgAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDEyL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMjAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBvrQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAyLTI0VDAzOjEzOjAyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6BEolKsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBPVQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTAyVDA1OjM0OjAxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw6x2wvB0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNy9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTcwMzAzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBB8ggEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE3LTAzLTA0VDAzOjQ0OjM4AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOw7BP3qAMAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE3L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNzAzMDMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNTAyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCFTAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA1LTAyVDIzOjM3OjMyAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswf4Awi4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA1MDIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxMS9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTEwNDMwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmXAEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDExLTA0LTMwVDIzOjM0OjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOswP22zY8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDExL0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxMTA0MzAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBWAwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKwwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTEzVDAzOjI5OjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKdZIEAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE1LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBXmAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE2VDAzOjI1OjU5AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwBJPQ+MAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTUuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBKPAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE4VDAzOjUwOjM3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwRR/z3QAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBaOwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTE5VDA2OjE3OjI2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwaGMtIcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjE5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBbowEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIwVDA0OjA2OjIwAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwhXlc60AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMTkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBmLwEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIxVDAzOjU3OjQxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwpUgncYAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIxLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBcsQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIyVDAzOjIwOjE3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuwxHNjvsAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBYeQEBdAjisk72GwDv6IFAGKKAAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTIzVDAzOjE1OjExAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuw5FZgVQAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nN+fN8A7+hkH488dAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISBg5rPAPStuFbIMHUBdWDIVH9t/wDrFWWrK/ptAXKw7JJ9jBsA6xVlqyv6bQFyqTBleV9TAPStuFbIMHQAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmEvMjAxNC9HRFNfMDc0NC0yNzU4L2lfcy9lcTAxMDAwMG1zLzIwMTQwMjIzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBBOzgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgaSAyMDE0LTAyLTI0VDAzOjExOjI1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuxBEDyucAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgaQAAAAFtPqj26U1Yb9A+rCb0guukoT6mcqqO1r9hAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2YS8yMDE0L0dEU18wNzQ0LTI3NTgvaV9zL2VxMDEwMDAwbXMvMjAxNDAyMjMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGVgEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTEzVDA2OjU2OjE1AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuryUAAAAAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMTEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCh8wEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAxLTE0VDA2OjUzOjQ2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOur6THfYkAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAxMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA3LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDSdwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA4VDAzOjU3OjUxAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvBUkaK0AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDcuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA4LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBDGgwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTA5VDA0OjExOjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvJZRKVcAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDguY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjA5LmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC6NQEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEwVDAzOjQ2OjE2AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvRQc0t4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMDkuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEwLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBC3CwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTExVDAzOjQ4OjQ0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvZRU9D4AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTAuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjExLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCG4QEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEyVDA0OjMzOjAzAAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvhhFZ4oAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTEuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEyLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCbnwEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTEzVDAzOjI5OjI3AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvpKeJq8AAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTIuY29tYl9hdmcuMDAwMS5maXRzLmZ6AAAAgWh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvZ2V0cHJvZHVjdC9iZ2RzL2RhdGEvZ2RzX2JpZy92NmIvMjAxNC9HRFNfMDc0NC0yNzU4L3Jfcy9lcTAxMDAwMG1zLzIwMTQwMjEzLmNvbWJfYXZnLjAwMDEuZml0cy5megAAAAppbWFnZS9maXRzBCdNAEBdAjist373wDv6IFAZOnkAAAAtQkdEUyBHRFNfMDc0NC0yNzU4IFNEU1MgciAyMDE0LTAyLTE0VDAzOjI1OjA0AAAAJlJvYm90aWMgQm9jaHVtIFR3aW4gVGVsZXNjb3BlIChSb0JvVFQpQOuvxI6Z+sAAAAACAAAAAgAAKjAAACowAAAAAj8tIIpVri44Py0gilWuLjgAAAAESUNSU0T6AABUQU4AAAACQLUYgAAAAABAtRiAAAAAAAAAAAJAXQI2nQNgp8A7+hkH9uDyAAAABL8tIIpVri44AAAAAAAAAAAAAAAAAAAAAD8tIIpVri44AAAABlNEU1MgcgAAAAFtPqSJCjt+bH4+p3RdQXEF9D6iL76awR0nAAAAAUYAAAAIQF1aISCE6CjAPStuFcW/j0BdWDIVQ9kEwDrFWWrdaHJAXKw7JMLoYcA6xVlq3WhyQFyqTBmB2RbAPStuFcW/jwAAAA1HRFNfMDc0NC0yNzU4QSAAAAAAAGppdm86Ly9vcmcuZ2F2by5kYy9+P2JnZHMvZGF0YS9nZHNfYmlnL3Y2Yi8yMDE0L0dEU18wNzQ0LTI3NTgvcl9zL2VxMDEwMDAwbXMvMjAxNDAyMTMuY29tYl9hdmcuMDAwMS5maXRzLmZ6
This service lets you access cutouts from BGDS images and retrieve -scaled versions.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta b/pyvo/discover/tests/data/sia1-responses/GET-dc.zah.uni-heidelberg.de-siap.xml-eqMj6uOsnSxbrIwk.meta deleted file mode 100644 index 9ad919b2adc34c549f558fc7517e0b6d6c528b9f..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1727 zcmZ`)(M}sj6s5(0i)nz8My=XNZloYc@!D(>RH&?q+HOinjD?+6id0Q!cgO66_3pAW z3m6Hhd8vvtZ=L>0KcNr(h<;4Ztk*V?S|l@b@7#N4=AL_Ie<}R&=lo3ecda*6Nk}SF zLEOk=`tWbH;4|v6L};~^u(Om2DJ&tA)Rk$%jJH7rI|u~}1(*DsHMuMG?|SpCzSe4< z2pJ_ztCAZ90dpmfLgbW=5iCt9uc#=h3Xx8V9|c*;Ee zE8qo7&RK#Z(#H4Qs%`CBc3EC?!oI;y=HB%AGCX|<8G_bs~`Q)I)1U=>8@k^wr*?x zeSa?NDZl8KHci7UreME9Pf#$e7GD`-e`MT?hd63j8Q%`=V1H$88%CC?>#|th>apeh zk!RXrt0z}H-YR>nAD~CJ%1&Z3=SP{Cj1o|SN7YAWWf3fgquz!Aa;L^AV{wHBkVQ^j z5xR;_xe?CF_;}XDwVGF5G_s)QG?~_afy5CyZK%~9Q}jIP4MNmfll3XOWR%qzh2;_i z-yxI2rD)#Y&^vwC-raesZ=hyOw`;qE3Nndkt0f=w<%hHp_93(mMH4R?P#(hZS?G}sX4IV(bqFX?6F%)TGsnR!?w-v83FQqy)cWnWQ*g zFYM&XdIX{Z8jE#|j*(O>^;=YooSDmQs9B)kVycvhb1TEqR22-A@y|k`us@g}8fS5g zY9bA=alU73nxYnx4_K5+eRy|Vd%Qg!PjDK60xgiNb%v%f@u5f<9bh^~T$V^I7Y)Cc WMk|@()iQDMsUedujlM~p)cO~<^qj{4 diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB deleted file mode 100644 index 414f956a..00000000 --- a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB +++ /dev/null @@ -1,23 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resource -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_level. -The terms are taken from the vocabulary -http://ivoa.net/rdf/voresource/content_type. -The allowed values for waveband include: -Radio, Millimeter, Infrared, Optical, UV, EUV, X-ray, Gamma-ray.Unambiguous reference to the resource conforming to the IVOA standard for identifiers.Resource type (something like vg:authority, vs:catalogservice, etc).A short name or abbreviation given to something, for presentation in space-constrained fields (up to 16 characters).The full name given to the resource.A hash-separated list of content levels specifying the intended audience.An account of the nature of the resource.URL pointing to a human-readable document describing this resource.The creator(s) of the resource in the order given by the resource record author, separated by semicolons.The UTC date and time this resource metadata description was created.The UTC date this resource metadata description was last updated.A statement of usage conditions (license, attribution, embargo, etc).A hash-separated list of natures or genres of the content of the resource.The format of source_value. This, in particular, can be ``bibcode''.A bibliographic reference from which the present resource is derived or extracted.A single numeric value representing the angle, given in decimal degrees, by which a positional query against this resource should be ``blurred'' in order to get an appropriate match.A hash-separated list of regions of the electro-magnetic spectrum that the resource's spectral coverage overlaps with.AAAAHGl2bzovL29yZy5nYXZvLmRjL2JnZHMvcS9zaWEAAAARdnM6Y2F0YWxvZ3NlcnZpY2UAAAAIYmdkcyBzaWEAAAApAEIAbwBjAGgAdQBtACAARwBhAGwAYQBjAHQAaQBjACAARABpAHMAawAgAFMAdQByAHYAZQB5ACAAKABCAEcARABTACkAIABpAG0AYQBnAGUAcwAAAAhyZXNlYXJjaAAAAgsAVABoAGUAIABCAG8AYwBoAHUAbQAgAEcAYQBsAGEAYwB0AGkAYwAgAEQAaQBzAGsAIABTAHUAcgB2AGUAeQAgAGkAcwAgAGEAbgAgAG8AbgBnAG8AaQBuAGcAIABwAHIAbwBqAGUAYwB0ACAAdABvACAAbQBvAG4AaQB0AG8AcgAgAHQAaABlAAoAcwB0AGUAbABsAGEAcgAgAGMAbwBuAHQAZQBuAHQAIABvAGYAIAB0AGgAZQAgAEcAYQBsAGEAYwB0AGkAYwAgAGQAaQBzAGsAIABpAG4AIABhACAANgAgAGQAZQBnAHIAZQBlACAAdwBpAGQAZQAgAHMAdAByAGkAcABlAAoAYwBlAG4AdABlAHIAZQBkACAAbwBuACAAdABoAGUAIABHAGEAbABhAGMAdABpAGMAIABwAGwAYQBuAGUALgAgAFQAaABlACAAZABhAHQAYQAgAGgAYQBzACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAHMAaQBuAGMAZQAKAG0AaQBkAC0AMgAwADEAMAAgAGkAbgAgAFMAbABvAGEAbgAgAHIAIABhAG4AZAAgAGkAIABzAGkAbQB1AGwAdABhAG4AZQBvAHUAcwBsAHkAIAB3AGkAdABoACAAdABoAGUAIABSAG8AQgBvAFQAVAAgAFQAZQBsAGUAYwBzAG8AcABlACAAYQB0AAoAdABoAGUAIABVAG4AaQB2AGUAcgBzAGkAdABhAGUAdABzAHMAdABlAHIAbgB3AGEAcgB0AGUAIABCAG8AYwBoAHUAbQAgAG4AZQBhAHIAIABDAGUAcgByAG8AIABBAHIAbQBhAHoAbwBuAGUAcwAgAGkAbgAgAHQAaABlACAAQwBoAGkAbABlAGEAbgAKAEEAdABhAGMAYQBtAGEAIABkAGUAcwBlAHIAdAAuACAASQB0ACAAYwBvAG4AdABhAGkAbgBzACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABvAGYAIABhAGIAbwB1AHQAIAAyAHgAMQAwAF4ANwAgAHMAdABhAHIAcwAgAG8AdgBlAHIACgBtAG8AcgBlACAAdABoAGEAbgAgAHMAZQB2AGUAbgAgAHkAZQBhAHIAcwAuACAAQQBkAGQAaQB0AGkAbwBuAGEAbABsAHkALAAgAGkAbgB0AGUAcgBtAGkAdAB0AGUAbgB0ACAAbQBlAGEAcwB1AHIAZQBtAGUAbgB0AHMAIABpAG4ACgBKAG8AaABuAHMAbwBuACAAVQBWAEIAIABhAG4AZAAgAFMAbABvAGEAbgAgAHoAIABoAGEAdgBlACAAYgBlAGUAbgAgAHIAZQBjAG8AcgBkAGUAZAAgAGEAcwAgAHcAZQBsAGwALgAAAC9odHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvaW5mbwAAACwASABhAGMAawBzAHQAZQBpAG4ALAAgAE0ALgA7ACAASABhAGEAcwAsACAATQAuADsAIABGAGUAaQBuACwAIABDAC4AOwAgAEMAaABpAG4AaQAsACAAUgAuAAAAEzIwMTctMTItMDJUMDk6MTY6MDAAAAATMjAyMy0wMi0wOVQxNDozMToxMQAAAEBJZiB5b3UgdXNlIEdEUyBkYXRhLCBwbGVhc2UgY2l0ZQo6YmliY29kZTpgMjAxNUFOLi4uLjMzNi4uNTkwSGAuAAAABnN1cnZleQAAAAdiaWJjb2RlAAAAEwAyADAAMQA1AEEATgAuAC4ALgAuADMAMwA2AC4ALgA1ADkAMABIf8AAAAAAAAdvcHRpY2FsAAAB6Wh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsbWV0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL2RsL2RsZ2V0Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS90YXA6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvdGFibGVNZXRhZGF0YTo6OnB5IFZPIHNlcDo6Omh0dHA6Ly9kYy56YWgudW5pLWhlaWRlbGJlcmcuZGUvYmdkcy9xL3NpYS9jYXBhYmlsaXRpZXM6OjpweSBWTyBzZXA6OjpodHRwOi8vZGMuemFoLnVuaS1oZWlkZWxiZXJnLmRlL2JnZHMvcS9zaWEvYXZhaWxhYmlsaXR5Ojo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9CR0RTOjo6cHkgVk8gc2VwOjo6aHR0cDovL2RjLnphaC51bmktaGVpZGVsYmVyZy5kZS9iZ2RzL3Evc2lhL3NpYXAueG1sPwAAAURpdm86Ly9pdm9hLm5ldC9zdGQvZGF0YWxpbmsjbGlua3MtMS4xOjo6cHkgVk8gc2VwOjo6aXZvOi8vaXZvYS5uZXQvc3RkL3NvZGEjc3luYy0xLjA6OjpweSBWTyBzZXA6Ojppdm86Ly9pdm9hLm5ldC9zdGQvdGFwI2F1eDo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI3RhYmxlczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2NhcGFiaWxpdGllczo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC92b3NpI2F2YWlsYWJpbGl0eTo6OnB5IFZPIHNlcDo6Ojo6OnB5IFZPIHNlcDo6Oml2bzovL2l2b2EubmV0L3N0ZC9zaWEAAADKdnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnM6cGFyYW1odHRwOjo6cHkgVk8gc2VwOjo6dnI6d2ViYnJvd3Nlcjo6OnB5IFZPIHNlcDo6OnZzOnBhcmFtaHR0cAAAAH5zdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6OjpzdGQ6OjpweSBWTyBzZXA6Ojo6OjpweSBWTyBzZXA6OjpzdGQAAABpOjo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6Ojo6cHkgVk8gc2VwOjo6
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaElJLKodOB.meta deleted file mode 100644 index 29a3f9a689e6ef29d5e684cbb9b747f216ad4cc2..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2854 zcmds3%Wm676g3(?opaIWGsuLY3vb6v>h0q*)Y$A$dhIrbuRH zC|LypG@GIZxGVcJ{epf(Kc;6$N^-JDQ!gtB;M_a+F>@d1&M)(STwR{aes9zDWLYY% zV#%z~ru6Aw$)Zc#CLz=0il8?!NhJ-bL~N;8kmfeHq{o4zKzhm>(ynKz^!Ie*UHUdn z&NHb(L20sVg}zUg^1=W*%N+reWKU$f@Vlx64`iQ2g#!5Y0w+yYdlO!B%3HMDI5;9Z z{T1dVi6IFr4vNL~UEX+fP^}p|My;eqo>XMNB(qxEG`5XRtut?Pg#*p+W}oZN!r*49 zcBiyQW~sJWyH(oUxxaP${`S4n!)HA$f6)p9MS-fQaRj}Kje_iDvc#r>D-#38 z0J-rI$CZ6S5l0{k3p2Iz15$2iWed4A4 zG5iMAZDVT-8CY+5L43TSM-L8e0WpertPkTZ?`?-`~BT z@6l*f>4#!aL3p#W&FWI;eF+T|9(lS$E>H6|WvvzolZ{O12^X`}EwU&?NsVzxoh~C+ zdJU1}$}aVJ?5kXBKNl-{4W$y0k`_mm{)V#aTeY1#x6>1}EtXrGJB&*iN>a=V z02bVbH{Zw2PLeO*-;X%5q)m|pm|>9!RR{<{G#7MG@I5z@Qs?V3Gkx?E*~Q6ax&a>d z{cv=O*G}eH5RTF(f4=yeV$*%}Hg)ZSNaoGZ9;ZKkvoJT;Z9YG29`qjA;q#cp`1@A9 z{qRA3_j&7k@Vl=b95h?aMsIDi?hQlFUaK|A070gqL9eA73dI6G$f#_`Q+`Gi1;~6F zl0VV2Nm{~-GfT?Mtt=>-j$#mtSG_@-e_ReBCDG>=eO!$DfEybl4A?~ivM(Ps zyG?vizj+sL@8YUh>gufR;g7LsI2`lQwm_MVjTr8s1^1-Kv#9Jq{b9FrxL^L^6_)>d zFwn4zNhS50ZV6e8@QkDMr&K1FmiSz#7lw7}frL7Se$W^DWe DDVX;$ diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl deleted file mode 100644 index 0caa54b6..00000000 --- a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl +++ /dev/null @@ -1,7 +0,0 @@ - -ADQL query translated to local SQL (for debugging)Original ADQL queryQuery successfulSoftware that produced this VOTableBase URI of the serverAdvice on citing this resourceAdvice on citing this resourceOriginating VO resourceData centre that has delivered the dataContact optionMore information on the data SourceMore information on the data SourceName of a person or entity that produced a contributing resourceThe parent resource.The IVOA identifier for the resource referred to.
\ No newline at end of file diff --git a/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta b/pyvo/discover/tests/data/sia1-responses/POST-reg.g-vo.org-sync-zBFGPNaEtPtv7FEl.meta deleted file mode 100644 index 98a27ac82f737722da1d4e09a0ff21808151d1ad..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3088 zcmb^zZBN@q7;R8kfKpa%(zI5(`Aeb2b`o9+G@(jK+R}!ECZXLXP1f0WiLW@e>pK%t zsnYso8j`=w`$hY*-!SdR>^a*>pnK^);4i*=?sX)byrQOF%xmjfUeZhxEI^^@YVx~%=(%gCxP=~5 z6BYBt4V2&6T`%r#7SNN!j>KQEJXcUxsAA{?-NJr$?IhQ)u;^L_pB3b48Li#QolCM*WjU}z&jg`9JmtA8Dqqy5d*Ccv2nnU zOGg3qF*q{gFd@6vr^5CK*m=}!cjD;NFmU4NmMw(8tLp*nX+2O@^Mal(u&?u>YsK~_ z_Dm8sd(NI;l`+YM;9wQ^!2CGM9m`84z1;VQFPnNn+tLUxYhD;C-QYy`Zl`THy!C^g@^5U|7y?Z4qmGVL-57^=3|h|O%J&nbXE>Ndc-HVe$h;v~Afu|KM6UrQx>==N4BDksM=4rX zl8{j@72Lv*%s)eRcCF&h)@FPT)eXl&e#gMv7-KY|1)C9?DOm)xMW}tKaD#Y#%v=C` zodGgVM(9FCvM!T#0202;o?U+V!v}!Mo zYweD*m|M&d??p(1;bQLU*w-tKCkgLL^+o+E8H3iX?-I`KTD`X4LG09HWDNyW7A!Fs z$)OLv$F1fe3IgbSfFcKh&HTS1A@r&HOf*I~sOF;P|zIgE-M8sub|O*E-Rtvs@uxLyi!Q`m))nJgV15 zbW;3=f7Asi1Rn z`GiV|{qlrLj}L0~Dmti^6-E?Lds6byWpZ)bw{f7LQ7jb{TBNMN zN`RsGx>`~`i3DI=t+n@C2S=TQW+Rb=(n{vY>mm!ggh4qYndQu)Jc(LK|B$AnC+ek| zRx6!K$|==7m diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 57d95fa8..d2d64e3b 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -15,7 +15,6 @@ from pyvo import discover from pyvo import registry from pyvo.discover import image -from pyvo.utils.testing import LearnableRequestMocker class FakeQueriable: @@ -79,7 +78,7 @@ def test_sia1(self): time.Time("1970-10-13T17:00:00"))) d._query_one_sia1(queriable) assert len(d.results) == 1 - assert abs(d.results[0].t_min-40872.583333333336)<1e-10 + assert abs(d.results[0].t_min-40872.583333333336) < 1e-10 assert queriable.search_kwargs == { 'pos': (0, 0), 'size': 1, 'intersect': 'overlaps'} @@ -102,7 +101,7 @@ def test_sia2(self): assert set(queriable.search_kwargs) == set(["time"]) assert abs(queriable.search_kwargs["time"][0].utc.value - -40872.54166667)<1e-8 + - 40872.54166667) < 1e-8 def test_sia2_nointerval(self): queriable = FakeQueriable() @@ -112,9 +111,9 @@ def test_sia2_nointerval(self): assert set(queriable.search_kwargs) == set(["time"]) assert abs(queriable.search_kwargs["time"][0].utc.value - -40872.54166667)<1e-8 + - 40872.54166667) < 1e-8 assert abs(queriable.search_kwargs["time"][1].utc.value - -40872.54166667)<1e-8 + - 40872.54166667) < 1e-8 def test_obscore(self): queriable = FakeQueriable() @@ -144,19 +143,14 @@ def test_obscore_nointerval(self): " AND t_min<=t_max AND 40872.541666666664<=40872.541666666664)") -@pytest.fixture -def _sia1_responses(requests_mock): - matcher = LearnableRequestMocker("sia1-responses") - requests_mock.add_matcher(matcher) - - def test_no_services_selected(): with pytest.raises(dal.DALQueryError) as excinfo: image.ImageDiscoverer().query_services() assert "No services to query." in str(excinfo.value) -def test_single_sia1(_sia1_responses): +@pytest.mark.remote_data +def test_single_sia1(): results, log = discover.images_globally( space=(116, -29, 0.1), time=time.Time(56383.105520834, format="mjd"), @@ -165,38 +159,34 @@ def test_single_sia1(_sia1_responses): im = results[0] assert im.s_xel1 == 10800. assert isinstance(im.em_min, float) - assert abs(im.s_dec+29)<2 + assert abs(im.s_dec+29) < 2 assert im.instrument_name == 'Robotic Bochum Twin Telescope (RoBoTT)' assert "BGDS GDS_" in im.obs_title assert "dc.zah.uni-heidelberg.de/getproduct/bgds/data" in im.access_url -@pytest.fixture -def _all_constraint_responses(requests_mock): - matcher = LearnableRequestMocker("image-with-all-constraints") - requests_mock.add_matcher(matcher) - - -def test_cone_and_spectral_point(_all_constraint_responses): +@pytest.mark.remote_data +def test_cone_and_spectral_point(): + # This should really return just a few services. If this + # starts hitting more services, see how we can throw them out + # again, perhaps using a time constraint. images, logs = discover.images_globally( space=(134, 11, 0.1), spectrum=600*u.eV) + assert len(logs) < 10, ("Too many services in test_cone_and_spectral." + " Try constraining the discovery phase more tightly to" + " keep this test economical") assert ("Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because" " it is served by ivo://org.gavo.dc/__system__/obscore/obscore" in logs) - assert len(images) == 8 - assert images[0].obs_collection == "RASS" + assert len(images) >= 8 + assert "RASS" in {im.obs_collection for im in images} -@pytest.fixture -def _servedby_elision_responses(requests_mock): - matcher = LearnableRequestMocker("servedby-elision-responses") - requests_mock.add_matcher(matcher) - - -def test_servedby_elision(_servedby_elision_responses): +@pytest.mark.remote_data +def test_servedby_elision(): d = discover.ImageDiscoverer(space=(3, 1, 0.2)) # siap2/sitewide has isservedby to tap d.set_services( @@ -212,13 +202,8 @@ def test_servedby_elision(_servedby_elision_responses): ' because it is served by ivo://org.gavo.dc/tap' in d.log_messages) -@pytest.fixture -def _access_url_elision_responses(requests_mock): - matcher = LearnableRequestMocker("access-url-elision") - requests_mock.add_matcher(matcher) - - -def test_access_url_elision(_access_url_elision_responses): +@pytest.mark.remote_data +def test_access_url_elision(): with pytest.warns(): d = discover.ImageDiscoverer( time=time.Time("1910-07-15", scale="utc"), From 26d6f3599ecf445cc7da5a49a4aebd8ca03f3551 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 14 May 2024 14:45:02 +0200 Subject: [PATCH 30/38] global discovery: Making query cancelling work. When resetting the services and hence emptying the queue, the iterator currently active would keep returning the queriables that were in there before. That's no longer the case now. Also, adding a few tests to improve coverage. --- pyvo/discover/image.py | 15 ++++-- pyvo/discover/tests/test_imagediscovery.py | 53 ++++++++++++++++++---- 2 files changed, 55 insertions(+), 13 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index 50f8c0ee..bb42010b 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -72,6 +72,8 @@ def __init__(self, res_rec): def __str__(self): return f"<{self.ivoid}>" + def __repr__(self): + return str(self) @functools.lru_cache(maxsize=None) def obscore_column_names(): @@ -382,6 +384,8 @@ def reset_services(self): """ with self._service_list_lock: self.sia1_recs, self.sia2_recs, self.obscore_recs = [], [], [] + self._log("Cancelling queries with {} service(s) queried" + .format(self.already_queried)) def _add_records(self, recgen: Generator[ImageFound, None, None]) -> int: @@ -450,7 +454,10 @@ def _query_sia1(self): " constraint") return - for rec in self.sia1_recs: + # we don't do a for loop here because we want to react to changes + # in self.sia1_recs + while self.sia1_recs: + rec = self.sia1_recs.pop() try: self._query_one_sia1(rec) except Exception as msg: @@ -483,7 +490,8 @@ def _query_one_sia2(self, rec: Queriable): def _query_sia2(self): """runs the SIA2 part of our discovery. """ - for rec in self.sia2_recs: + while self.sia2_recs: + rec = self.sia2_recs.pop() try: self._query_one_sia2(rec) except Exception as msg: @@ -527,7 +535,8 @@ def _query_obscore(self): where_clause = "WHERE "+(" AND ".join(where_parts)) - for rec in self.obscore_recs: + while self.obscore_recs: + rec = self.obscore_recs.pop() try: self._query_one_obscore(rec, where_clause) except Exception as msg: diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index d2d64e3b..831ff4ee 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -17,6 +17,12 @@ from pyvo.discover import image +class TestImageFound: + def testBadAttrName(self): + with pytest.raises(TypeError): + i = image.ImageFound("ivo://x-fake", {"invented": None}) + + class FakeQueriable: """a scaffolding class to record queries built by the various discovery methods. @@ -170,16 +176,24 @@ def test_cone_and_spectral_point(): # This should really return just a few services. If this # starts hitting more services, see how we can throw them out # again, perhaps using a time constraint. + watcher_msgs = [] + def test_watcher(msg): + watcher_msgs.append(msg) + images, logs = discover.images_globally( space=(134, 11, 0.1), - spectrum=600*u.eV) + spectrum=600*u.eV, + time=(time.Time('1990-01-01'), time.Time('1999-12-31')), + watcher=test_watcher) assert len(logs) < 10, ("Too many services in test_cone_and_spectral." " Try constraining the discovery phase more tightly to" " keep this test economical") - assert ("Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because" - " it is served by ivo://org.gavo.dc/__system__/obscore/obscore" - in logs) + + skip_msg = ("Skipping ivo://org.gavo.dc/__system__/siap2/sitewide because" + " it is served by ivo://org.gavo.dc/__system__/obscore/obscore") + assert skip_msg in logs + assert skip_msg in watcher_msgs assert len(images) >= 8 assert "RASS" in {im.obs_collection for im in images} @@ -197,7 +211,7 @@ def test_servedby_elision(): assert d.sia2_recs == [] assert len(d.obscore_recs) == 1 - assert d.obscore_recs[0].ivoid == "ivo://org.gavo.dc/tap" + assert repr(d.obscore_recs[0]) == "" assert ('Skipping ivo://org.gavo.dc/__system__/siap2/sitewide' ' because it is served by ivo://org.gavo.dc/tap' in d.log_messages) @@ -205,22 +219,41 @@ def test_servedby_elision(): @pytest.mark.remote_data def test_access_url_elision(): with pytest.warns(): - d = discover.ImageDiscoverer( + di = discover.ImageDiscoverer( time=time.Time("1910-07-15", scale="utc"), spectrum=400*u.nm) - d.set_services( + di.set_services( registry.search( registry.Ivoid( "ivo://org.gavo.dc/tap", "ivo://org.gavo.dc/__system__/siap2/sitewide")), # that's important here: we *want* to query the same stuff twice purge_redundant=False) - d.query_services() + di.query_services() # make sure we found anything at all - assert d.results + assert di.results assert len([1 for lm in d.log_messages if "skipped" in lm]) == 0 # make sure there are no duplicate records - access_urls = [im.access_url for im in d.results] + access_urls = [im.access_url for im in di.results] assert len(access_urls) == len(set(access_urls)) + + +@pytest.mark.remote_data +def test_cancelling(): + di = discover.ImageDiscoverer( + time=time.Time("1980-07-15", scale="utc"), + spectrum=400*u.nm, + timeout=1) + + def query_killer(msg): + if msg.startswith("Querying") and di.already_queried>0: + di.reset_services() + di.watcher = query_killer + + di.set_services(registry.search(servicetype="sia2")) + di.query_services() + + assert ('Cancelling queries with 1 service(s) queried' + in di.log_messages) From c84bb5918bd6e746a6d7088c8b25cb1a29f4179b Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 14 May 2024 15:29:44 +0200 Subject: [PATCH 31/38] global discovery: watchers now receive a discoverer instance, too. --- docs/discover/index.rst | 9 ++++++++- pyvo/discover/image.py | 8 ++++---- pyvo/discover/tests/test_imagediscovery.py | 12 ++++++------ 3 files changed, 18 insertions(+), 11 deletions(-) diff --git a/docs/discover/index.rst b/docs/discover/index.rst index dc232254..4b8c28a9 100644 --- a/docs/discover/index.rst +++ b/docs/discover/index.rst @@ -103,12 +103,19 @@ going on, you can pass in a function accepting a single string as import datetime - def watch(msg): + def watch(disco, msg): print(datetime.datetime.now(), msg) found, log = discover.images_globally( space=(3, 1, 0.2), watcher=watch) +Here, ``disco`` is an ``ImageDiscoverer`` instance; this way, you can +further inspect the state of things, e.g., by looking at the +``already_queried`` and ``failed_services`` attributes containing the +number of total services tried and of services that gave errors, +respectively. Also, although that clearly goes beyond watching, you can +call the ``reset_services()`` method. This empties the query queues and +thus in effect stops the discovery process. Setting Timeouts ---------------- diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index bb42010b..d92d6bbf 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -221,7 +221,7 @@ def _info(self, message: str) -> None: """sends message to our watcher (if there is any) """ if self.watcher is not None: - self.watcher(message) + self.watcher(self, message) def _log(self, message: str) -> None: """logs message. @@ -576,7 +576,7 @@ def images_globally( spectrum: Optional[quantity.Quantity] = None, time: Optional[time.Time] = None, inclusive: bool = False, - watcher: Optional[Callable[[str], None]] = None, + watcher: Optional[Callable[['ImageDiscoverer', str], None]] = None, timeout: float = 20, services: Optional[registry.RegistryResults] = None)\ -> Tuple[List[obscore.ObsCoreMetadata], List[str]]: @@ -601,8 +601,8 @@ def images_globally( STC coverage. By 2023, it's a good idea to do that as many relevant archives do not do that. watcher : - A callable that will be called with strings perhaps suitable - for displaying to a human. + A callable that will be called with the ImageDiscoverer instance and + a string perhaps suitable for displaying to a human. services : An optional `~pyvo.registry.RegistryResults` instance to override automatic services detection. diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 831ff4ee..f2dc970e 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -242,15 +242,15 @@ def test_access_url_elision(): @pytest.mark.remote_data def test_cancelling(): + def query_killer(disco, msg): + if msg.startswith("Querying") and di.already_queried>0: + disco.reset_services() + di = discover.ImageDiscoverer( time=time.Time("1980-07-15", scale="utc"), spectrum=400*u.nm, - timeout=1) - - def query_killer(msg): - if msg.startswith("Querying") and di.already_queried>0: - di.reset_services() - di.watcher = query_killer + timeout=1, + watcher = query_killer) di.set_services(registry.search(servicetype="sia2")) di.query_services() From 30e3d26d1124b32906d9833c22611f8b8c60a6ea Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Tue, 14 May 2024 15:52:04 +0200 Subject: [PATCH 32/38] global discovery: more test coverage. --- pyvo/discover/image.py | 1 + pyvo/discover/tests/test_imagediscovery.py | 45 +++++++++++++++++++--- 2 files changed, 41 insertions(+), 5 deletions(-) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index d92d6bbf..d50bd0e9 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -75,6 +75,7 @@ def __str__(self): def __repr__(self): return str(self) + @functools.lru_cache(maxsize=None) def obscore_column_names(): """returns the names of obscore columns. diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index f2dc970e..c06c005e 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -20,7 +20,7 @@ class TestImageFound: def testBadAttrName(self): with pytest.raises(TypeError): - i = image.ImageFound("ivo://x-fake", {"invented": None}) + image.ImageFound("ivo://x-fake", {"invented": None}) class FakeQueriable: @@ -149,12 +149,45 @@ def test_obscore_nointerval(self): " AND t_min<=t_max AND 40872.541666666664<=40872.541666666664)") +class TestSpaceCondition: + def test_sia1_fails_without_space(self): + queriable = FakeQueriable() + di = discover.ImageDiscoverer( + time=( + time.Time("1970-10-13T13:00:00"))) + di.sia1_recs = [queriable] + di.query_services() + assert di.log_messages == [ + 'SIA1 service(s) skipped due to missing space constraint'] + + def test_sia2(self): + queriable = FakeQueriable() + di = discover.ImageDiscoverer(space=(30, 21, 1)) + di.sia2_recs = [queriable] + di.query_services() + assert queriable.search_kwargs == {'pos': (30, 21, 1)} + + def test_obscore(self): + queriable = FakeQueriable() + di = discover.ImageDiscoverer(space=(30, 21, 1)) + di.obscore_recs = [queriable] + di.query_services() + assert queriable.search_args == ( + "select * from ivoa.obscore WHERE dataproduct_type='image'" + " AND (1=contains(point('ICRS', s_ra, s_dec)," + " circle('ICRS', 30, 21, 1))" + " or 1=intersects(circle(30, 21, 1), s_region))",) + + def test_no_services_selected(): with pytest.raises(dal.DALQueryError) as excinfo: image.ImageDiscoverer().query_services() assert "No services to query." in str(excinfo.value) +# Tests requiring remote data below this line + + @pytest.mark.remote_data def test_single_sia1(): results, log = discover.images_globally( @@ -177,7 +210,8 @@ def test_cone_and_spectral_point(): # starts hitting more services, see how we can throw them out # again, perhaps using a time constraint. watcher_msgs = [] - def test_watcher(msg): + + def test_watcher(disco, msg): watcher_msgs.append(msg) images, logs = discover.images_globally( @@ -233,7 +267,7 @@ def test_access_url_elision(): # make sure we found anything at all assert di.results - assert len([1 for lm in d.log_messages if "skipped" in lm]) == 0 + assert len([1 for lm in di.log_messages if "skipped" in lm]) == 0 # make sure there are no duplicate records access_urls = [im.access_url for im in di.results] @@ -242,15 +276,16 @@ def test_access_url_elision(): @pytest.mark.remote_data def test_cancelling(): + def query_killer(disco, msg): - if msg.startswith("Querying") and di.already_queried>0: + if msg.startswith("Querying") and di.already_queried > 0: disco.reset_services() di = discover.ImageDiscoverer( time=time.Time("1980-07-15", scale="utc"), spectrum=400*u.nm, timeout=1, - watcher = query_killer) + watcher=query_killer) di.set_services(registry.search(servicetype="sia2")) di.query_services() From 5411ea803a1d975a68596ffd5a6e2fcd79551976 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Fri, 19 Jul 2024 11:03:46 +0200 Subject: [PATCH 33/38] Documentation fixes. This is in response to https://github.com/astropy/pyvo/pull/470#issuecomment-2230942121. --- docs/discover/index.rst | 25 ++++++++++++++++++++----- pyvo/discover/image.py | 2 +- 2 files changed, 21 insertions(+), 6 deletions(-) diff --git a/docs/discover/index.rst b/docs/discover/index.rst index 4b8c28a9..ac7fbe23 100644 --- a/docs/discover/index.rst +++ b/docs/discover/index.rst @@ -49,9 +49,10 @@ For instance:: from astropy import time datasets, log = discover.images_globally( - space=(274.6880, -13.7920, 0.1), - spectrum=500.7*u.nm, + space=(273.5, -12.1, 0.1), + spectrum=1*u.nm, time=(time.Time('1995-01-01'), time.Time('1995-12-31'))) + print(datasets) The function returns a pair of lists. ``datasets`` is a list of `~pyvo.discover.image.ImageFound` instances. This is the (potentially @@ -186,9 +187,23 @@ is what you want, but if you really do not want this, you can pass one match per access URL of the dataset. Once you have set the services, call ``query_services()`` to fill the -``results`` and ``log`` attributes. It may be informative to watch -these change from, say, a different thread. Changing their content has -undefined results. +``results`` and ``log_messages`` attributes. It may be informative to +watch these change from, say, a different thread. Changing their +content has undefined results. + +A working example would look like this:: + + from pyvo import discover, registry + from astropy.time import Time + + im_discoverer = discover.image.ImageDiscoverer( + space=(274.6880, -13.7920, 0.1), + time=(Time('1996-10-04'), Time('1996-10-10'))) + im_discoverer.set_services( + registry.search(keywords=["heasarc rass"])) + im_discoverer.query_services() + print(im_discoverer.log_messages) + print(im_discoverer.results) diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index d50bd0e9..f2b28f95 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -558,7 +558,7 @@ def query_services(self): """queries the discovered image services according to our constraints. - This creates and fills the results and the log attributes. + This creates and fills the results and the log_messages attributes. """ if (not self.sia1_recs and not self.sia2_recs From f384d0de790eaa95fceff960e54100e7436979f8 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 8 Aug 2024 17:06:45 +0200 Subject: [PATCH 34/38] pyvo.discover now emits a prototype warning on import. Also, fixing a few tests that failed because of external changes. --- pyvo/discover/__init__.py | 8 ++++++++ pyvo/discover/tests/test_imagediscovery.py | 9 ++++++++- pyvo/registry/rtcons.py | 6 +++--- pyvo/registry/tests/test_rtcons.py | 16 ++++++++++------ 4 files changed, 29 insertions(+), 10 deletions(-) diff --git a/pyvo/discover/__init__.py b/pyvo/discover/__init__.py index 533735b8..4c6fc826 100644 --- a/pyvo/discover/__init__.py +++ b/pyvo/discover/__init__.py @@ -3,4 +3,12 @@ Various functions dealing with global data disovery. """ +import warnings +from pyvo.utils.prototype import PrototypeWarning + +# if you remove this warning, also remove the ignorere in test_imagediscovery. +warnings.warn("pyvo.discover's API is still under design in pyVO 1.6 and" + " may change without prior notice. Feedback to the authors is most" + " welcome.", PrototypeWarning) + from .image import images_globally, ImageDiscoverer diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index c06c005e..97878bbd 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -12,9 +12,16 @@ from astropy import units as u from pyvo import dal -from pyvo import discover from pyvo import registry + +# remove the following paragraph once discover's API has stabilised and we +# no longer raise a PrototypeWarning. +from pyvo.utils.prototype import PrototypeWarning +import warnings +warnings.simplefilter("ignore", PrototypeWarning) + from pyvo.discover import image +from pyvo import discover class TestImageFound: diff --git a/pyvo/registry/rtcons.py b/pyvo/registry/rtcons.py index 741897c8..262e94d6 100644 --- a/pyvo/registry/rtcons.py +++ b/pyvo/registry/rtcons.py @@ -564,8 +564,8 @@ def _make_obscore_constraint(self): f" AND 1 = ivo_nocasematch(detail_value, '{obscore_pat}')") def _make_obscore_new_constraint(self): - self._extra_tables = ["rr.res_table"] - return ("table_utype like 'ivo://ivoa.net/std/obscore#table-1.%'" + return "rr.res_table NATURAL JOIN rr.resource", ( + "table_utype LIKE 'ivo://ivoa.net/std/obscore#table-1.%'" # Only use catalogresource-typed records to keep out # full TAP services that may have the table in their # tablesets. @@ -795,7 +795,7 @@ def get_search_condition(self, service): cond = super().get_search_condition(service) if self.inclusive: - return cond+" OR coverage IS NULL" + return cond[:-1]+" OR coverage IS NULL)" else: return cond diff --git a/pyvo/registry/tests/test_rtcons.py b/pyvo/registry/tests/test_rtcons.py index 7144b9db..d082c4b2 100644 --- a/pyvo/registry/tests/test_rtcons.py +++ b/pyvo/registry/tests/test_rtcons.py @@ -220,9 +220,11 @@ def test_junk_rejected(self): def test_obscore_new(self): cons = rtcons.Datamodel("obscore_new") assert (cons.get_search_condition(FAKE_GAVO) - == "table_utype like 'ivo://ivoa.net/std/obscore#table-1.%'" - " AND res_type = 'vs:catalogresource'") - assert (cons._extra_tables == ["rr.res_table"]) + == "ivoid IN (SELECT DISTINCT ivoid FROM rr.res_table" + " NATURAL JOIN rr.resource" + " WHERE table_utype LIKE 'ivo://ivoa.net/std/obscore#table-1.%'" + " AND res_type = 'vs:catalogresource')") + assert (cons._extra_tables == []) def test_obscore(self): cons = rtcons.Datamodel("ObsCore") @@ -303,7 +305,7 @@ def test_moc(self): def test_moc_and_inclusive(self): cons = registry.Spatial("0/1-3 3/", inclusive=True) assert cons.get_search_condition(FAKE_GAVO) == \ - "1 = CONTAINS(MOC('0/1-3 3/'), coverage) OR coverage IS NULL" + "ivoid IN (SELECT DISTINCT ivoid FROM rr.stc_spatial WHERE 1 = CONTAINS(MOC('0/1-3 3/'), coverage)) OR coverage IS NULL" def test_SkyCoord(self): cons = registry.Spatial(SkyCoord(3 * u.deg, -30 * u.deg)) @@ -405,7 +407,8 @@ def test_frequency(self): def test_frequency_and_inclusive(self): cons = registry.Spectral(2 * u.GHz, inclusive=True) assert (cons.get_search_condition(FAKE_GAVO) - == "(1.32521403e-24 BETWEEN spectral_start AND spectral_end)" + == "(ivoid IN (SELECT DISTINCT ivoid FROM rr.stc_spectral" + " WHERE 1.32521403e-24 BETWEEN spectral_start AND spectral_end))" " OR NOT EXISTS(SELECT 1 FROM rr.stc_spectral AS inner_s" " WHERE inner_s.ivoid=rr.resource.ivoid)") @@ -436,7 +439,8 @@ def test_plain_float(self): def test_plain_float_and_inclusive(self): cons = registry.Temporal((54130, 54200), inclusive=True) assert (cons.get_search_condition(FAKE_GAVO) - == "(1 = ivo_interval_overlaps(time_start, time_end, 54130, 54200))" + == "(ivoid IN (SELECT DISTINCT ivoid FROM rr.stc_temporal" + " WHERE 1 = ivo_interval_overlaps(time_start, time_end, 54130, 54200)))" " OR NOT EXISTS(SELECT 1 FROM rr.stc_temporal AS inner_t" " WHERE inner_t.ivoid=rr.resource.ivoid)") From 51c2d91cfbafce81a0f1ce48aa6b70a5f6e86f0f Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Brigitta=20Sip=C5=91cz?= Date: Tue, 8 Oct 2024 20:42:52 -0700 Subject: [PATCH 35/38] MAINT: dealing with warning at collection time --- pyvo/discover/tests/test_imagediscovery.py | 7 ------- setup.cfg | 4 +++- 2 files changed, 3 insertions(+), 8 deletions(-) diff --git a/pyvo/discover/tests/test_imagediscovery.py b/pyvo/discover/tests/test_imagediscovery.py index 97878bbd..4b57f697 100644 --- a/pyvo/discover/tests/test_imagediscovery.py +++ b/pyvo/discover/tests/test_imagediscovery.py @@ -13,13 +13,6 @@ from pyvo import dal from pyvo import registry - -# remove the following paragraph once discover's API has stabilised and we -# no longer raise a PrototypeWarning. -from pyvo.utils.prototype import PrototypeWarning -import warnings -warnings.simplefilter("ignore", PrototypeWarning) - from pyvo.discover import image from pyvo import discover diff --git a/setup.cfg b/setup.cfg index d53e217c..a95d07bb 100644 --- a/setup.cfg +++ b/setup.cfg @@ -17,7 +17,9 @@ filterwarnings = # Numpy 2.0 deprecations triggered by upstream libraries. # Exact warning messages differ, thus using a super generic filter. ignore:numpy.core:DeprecationWarning - +# We need to ignore this module level warning to not cause issues at collection time. +# Remove it once warning is removed from code (in 1.7). + ignore:pyvo.discover:pyvo.utils.prototype.PrototypeWarning [flake8] max-line-length = 110 From b4fed088485f795f8d8d2787779511230375fd52 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Brigitta=20Sip=C5=91cz?= Date: Tue, 8 Oct 2024 20:43:06 -0700 Subject: [PATCH 36/38] TST: unrelated test fix, rebase should resolve it --- pyvo/registry/tests/test_regtap.py | 4 ++-- pyvo/registry/tests/test_rtcons.py | 5 +++-- 2 files changed, 5 insertions(+), 4 deletions(-) diff --git a/pyvo/registry/tests/test_regtap.py b/pyvo/registry/tests/test_regtap.py index ac3cdb13..71c96205 100644 --- a/pyvo/registry/tests/test_regtap.py +++ b/pyvo/registry/tests/test_regtap.py @@ -88,8 +88,8 @@ def keywordstest_callback(request, context): data = dict(parse_qsl(request.body)) query = data['QUERY'] - assert (" UNION SELECT ivoid FROM rr.res_subject WHERE" - " rr.res_subject.res_subject ILIKE '%single%'") in query + assert (" UNION ALL SELECT DISTINCT ivoid FROM rr.res_subject WHERE " + "rr.res_subject.res_subject ILIKE '%single%'") in query assert "1=ivo_hasword(res_description, 'single') " in query assert "1=ivo_hasword(res_title, 'single')" in query diff --git a/pyvo/registry/tests/test_rtcons.py b/pyvo/registry/tests/test_rtcons.py index d082c4b2..86467d05 100644 --- a/pyvo/registry/tests/test_rtcons.py +++ b/pyvo/registry/tests/test_rtcons.py @@ -304,8 +304,9 @@ def test_moc(self): def test_moc_and_inclusive(self): cons = registry.Spatial("0/1-3 3/", inclusive=True) - assert cons.get_search_condition(FAKE_GAVO) == \ - "ivoid IN (SELECT DISTINCT ivoid FROM rr.stc_spatial WHERE 1 = CONTAINS(MOC('0/1-3 3/'), coverage)) OR coverage IS NULL" + assert cons.get_search_condition(FAKE_GAVO) == ( + "ivoid IN (SELECT DISTINCT ivoid FROM rr.stc_spatial WHERE 1 = " + "CONTAINS(MOC('0/1-3 3/'), coverage) OR coverage IS NULL)") def test_SkyCoord(self): cons = registry.Spatial(SkyCoord(3 * u.deg, -30 * u.deg)) From 8caab1fe9a8a4045c9c9a2e3472008a167bb9c34 Mon Sep 17 00:00:00 2001 From: Markus Demleitner Date: Thu, 10 Oct 2024 15:20:25 +0200 Subject: [PATCH 37/38] Minor changes after bsipocz' 2024-10-09 review. --- docs/discover/index.rst | 4 ++-- docs/index.rst | 1 - pyvo/discover/__init__.py | 4 +++- pyvo/discover/image.py | 9 ++++++--- 4 files changed, 11 insertions(+), 7 deletions(-) diff --git a/docs/discover/index.rst b/docs/discover/index.rst index ac7fbe23..327e9280 100644 --- a/docs/discover/index.rst +++ b/docs/discover/index.rst @@ -55,7 +55,7 @@ For instance:: print(datasets) The function returns a pair of lists. ``datasets`` is a list of -`~pyvo.discover.image.ImageFound` instances. This is the (potentially +`~pyvo.discover.ImageFound` instances. This is the (potentially long) list of datasets located. The second returned value, ``log``, is a sequence of strings noting @@ -210,4 +210,4 @@ A working example would look like this:: Reference/API ============= -.. automodapi:: pyvo.discover.image +.. automodapi:: pyvo.discover diff --git a/docs/index.rst b/docs/index.rst index 43d168bc..5ed65e83 100644 --- a/docs/index.rst +++ b/docs/index.rst @@ -139,4 +139,3 @@ Using ``pyvo`` mivot/index utils/index utils/prototypes - utils/testing diff --git a/pyvo/discover/__init__.py b/pyvo/discover/__init__.py index 4c6fc826..0ed050c6 100644 --- a/pyvo/discover/__init__.py +++ b/pyvo/discover/__init__.py @@ -11,4 +11,6 @@ " may change without prior notice. Feedback to the authors is most" " welcome.", PrototypeWarning) -from .image import images_globally, ImageDiscoverer +from .image import images_globally, ImageDiscoverer, ImageFound + +__all__ = ['images_globally', "ImageDiscoverer", "ImageFound"] diff --git a/pyvo/discover/image.py b/pyvo/discover/image.py index f2b28f95..820dae3b 100644 --- a/pyvo/discover/image.py +++ b/pyvo/discover/image.py @@ -39,6 +39,8 @@ from typing import Callable, Generator, List, Optional, Set, Tuple from astropy.units import quantity +__all__ = ["ImageFound", "ImageDiscoverer", "images_globally"] + # We should probably have a general way to set query timeouts in pyVO. # For now, we don't, but for global discovery there's really no way @@ -59,7 +61,7 @@ class Queriable: """A facade for a queriable service. We keep these rather than work on - `pyvo.registry.regtap.RegistryResource`-s directly because the latter + `pyvo.registry.RegistryResource`-s directly because the latter actually live in VOTables which are very hard to manipulate. They are constructed with a resource record. @@ -599,7 +601,7 @@ def images_globally( (if it declares a time). inclusive : Set to True to incluse services that do not declare their - STC coverage. By 2023, it's a good idea to do that as many + STC coverage. As of 2024, it may be advisable to do that as many relevant archives do not do that. watcher : A callable that will be called with the ImageDiscoverer instance and @@ -615,7 +617,8 @@ def images_globally( Returns ------- discovered_images, log_lines - The images found are returned in a list of `ImageFound` instances. + The images found are returned in a list of `pyvo.discover.ImageFound` + instances. log_lines is a list of strings reporting which services were queried with which result (and possibly more). So far, this is not considered machine-readable. From 1e696aca3bb13a478647260034889d530d296cae Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Brigitta=20Sip=C5=91cz?= Date: Mon, 14 Oct 2024 14:53:34 -0700 Subject: [PATCH 38/38] DOC: We can't link the module before generating its API docs --- docs/utils/index.rst | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/docs/utils/index.rst b/docs/utils/index.rst index 4832ba5f..c04997e9 100644 --- a/docs/utils/index.rst +++ b/docs/utils/index.rst @@ -1,8 +1,8 @@ .. _pyvo-utils: -***************************** -pyVO utilities (`pyvo.utils`) -***************************** +******************************* +pyVO utilities (``pyvo.utils``) +******************************* This subpackage collects a few packages intended to help developing and maintaining pyVO. All of this is not part of pyVO's public API and