skip to main content

gaia early data release 3 documentation

13.1 Main tables

13.1.1 gaia_source

This table has an entry for every Gaia observed source as listed in the Main Database accumulating catalogue version from which the catalogue release has been generated. It contains the basic source parameters, that is only final data (no epoch data) and no spectra (neither final nor epoch).

Columns description:

solution_id : Solution Identifier (long)

All Gaia data processed by the Data Processing and Analysis Consortium comes tagged with a solution identifier. This is a numeric field attached to each table row that can be used to unequivocally identify the version of all the subsystems that where used in the generation of the data as well as the input data used. It is mainly for internal DPAC use but is included in the published data releases to enable end users to examine the provenance of processed data products. To decode a given solution ID visit https://gaia.esac.esa.int/decoder/solnDecoder.jsp

designation : Unique source designation (unique across all Data Releases) (string)

A source designation, unique across all Gaia Data Releases, that is constructed from the prefix “Gaia DRx ” followed by a string of digits corresponding to source_id (3 space–separated words in total). Note that the integer source identifier source_id is not guaranteed to be unique across Data Releases; moreover it is not guaranteed that the same astronomical source will always have the same source_id in different Data Releases. Hence the only safe way to compare source records between different Data Releases in general is to check the records of proximal source(s) in the same small part of the sky.

source_id : Unique source identifier (unique within a particular Data Release) (long)

A unique numerical identifier of the source, encoding the approximate position of the source (roughly to the nearest arcmin), the provenance (data processing centre where it was created), a running number, and a component number.

The approximate equatorial (ICRS) position is encoded using the nested HEALPix scheme at level 12 (Nside = 4096), which divides the sky into 200 million pixels of about 0.7 arcmin2.

The source ID consists of a 64-bit integer, least significant bit = 1 and most significant bit = 64, comprising:

  • a HEALPix index number (sky pixel) in bits 36 - 63; by definition the smallest HEALPix index number is zero.

  • a 3-bit Data Processing Centre code in bits 33 - 35; for example MOD(source_id / 4294967296, 8) can be used to distinguish between sources initialised via the Initial Gaia Source List by the Torino DPC (code = 0) and sources otherwise detected and assigned by Gaia observations (code >0)

  • a 25-bit plus 7 bit sequence number within the HEALPix pixel in bits 1 - 32 split into:

    • a 25 bit running number in bits 8 – 32; the running numbers are defined to be positive, i.e. never zero

    • a 7-bit component number in bits 1 – 7

This means that the HEALpix index at level 12 of a given source is contained in the most significant bits. HEALpix index of level 12 and lower can thus be retrieved as follows:

  • HEALpix index at level 12 = source_id / 34359738368

  • HEALpix index at level 11 = source_id / 137438953472

  • HEALpix index level 10 = source_id / 549755813888

  • HEALpix index at level n = source_id / (235×4(12-n)) = source_id / 2(59-2n)

Additional details can be found in the Gaia DPAC public document Source Identifiers — Assignment and Usage throughout DPAC (document code GAIA–C3–TN–ARI–BAS–020) available from https://www.cosmos.esa.int/web/gaia/public-dpac-documents

random_index : Random index used to select subsets (long)

Random index which can be used to select smaller subsets of the data that are still representative. The column contains a random permutation of the numbers from 0 to N-1, where N is the number of sources in the table.

The random index can be useful for validation (testing on 10 different random subsets), visualization (displaying 1% of the data), and statistical exploration of the data, without the need to download all the data.

ref_epoch : Reference epoch (double, Time[Julian Years])

Reference epoch to which the astrometric source parameters are referred, expressed as a Julian Year in TCB.

ra : Right ascension (double, Angle[deg])

Barycentric right ascension α of the source in ICRS at the reference epoch ref_epoch

ra_error : Standard error of right ascension (float, Angle[mas])

Standard error σα*σαcosδ of the right ascension of the source in ICRS at the reference epoch ref_epoch.

dec : Declination (double, Angle[deg])

Barycentric declination δ of the source in ICRS at the reference epoch ref_epoch

dec_error : Standard error of declination (float, Angle[mas])

Standard error σδ of the declination of the source in ICRS at the reference epoch ref_epoch

parallax : Parallax (double, Angle[mas] )

Absolute stellar parallax ϖ of the source at the reference epoch ref_epoch

parallax_error : Standard error of parallax (float, Angle[mas] )

Standard error σϖ of the stellar parallax at the reference epoch ref_epoch

parallax_over_error : Parallax divided by its standard error (float)

Parallax divided by its standard error

pm : Total proper motion (float, Angular Velocity[mas/year])

The total proper motion calculated as the magnitude of the resultant vector of the proper motion component vectors pmra and pmdec, i.e. 𝚙𝚖2=𝚙𝚖𝚛𝚊2+𝚙𝚖𝚍𝚎𝚌2.

pmra : Proper motion in right ascension direction (double, Angular Velocity[mas/year])

Proper motion in right ascension μα*μαcosδ of the source in ICRS at the reference epoch ref_epoch. This is the local tangent plane projection of the proper motion vector in the direction of increasing right ascension.

pmra_error : Standard error of proper motion in right ascension direction (float, Angular Velocity[mas/year] )

Standard error σμα* of the local tangent plane projection of the proper motion vector in the direction of increasing right ascension at the reference epoch ref_epoch

pmdec : Proper motion in declination direction (double, Angular Velocity[mas/year] )

Proper motion in declination μδ of the source at the reference epoch ref_epoch. This is the projection of the proper motion vector in the direction of increasing declination.

pmdec_error : Standard error of proper motion in declination direction (float, Angular Velocity[mas/year] )

Standard error σμδ of the proper motion component in declination at the reference epoch ref_epoch

ra_dec_corr : Correlation between right ascension and declination (float, Dimensionless[see description])

Correlation coefficient ρ(α,δ) between right ascension and declination, a dimensionless quantity in the range [-1,+1]

ra_parallax_corr : Correlation between right ascension and parallax (float, Dimensionless[see description])

Correlation coefficient ρ(α,ϖ) between right ascension and parallax, a dimensionless quantity in the range [-1,+1]

ra_pmra_corr : Correlation between right ascension and proper motion in right ascension (float, Dimensionless[see description])

Correlation coefficient ρ(α,μα*) between right ascension and proper motion in right ascension, a dimensionless quantity in the range [-1,+1]

ra_pmdec_corr : Correlation between right ascension and proper motion in declination (float, Dimensionless[see description])

Correlation coefficient ρ(α,μδ) between right ascension and proper motion in declination, a dimensionless quantity in the range [-1,+1]

dec_parallax_corr : Correlation between declination and parallax (float, Dimensionless[see description])

Correlation coefficient ρ(δ,ϖ) between declination and parallax, a dimensionless quantity in the range [-1,+1]

dec_pmra_corr : Correlation between declination and proper motion in right ascension (float, Dimensionless[see description])

Correlation coefficient ρ(δ,μα*) between declination and proper motion in right ascension, a dimensionless quantity in the range [-1,+1]

dec_pmdec_corr : Correlation between declination and proper motion in declination (float, Dimensionless[see description])

Correlation coefficient ρ(δ,μδ) between declination and proper motion in declination, a dimensionless quantity in the range [-1,+1]

parallax_pmra_corr : Correlation between parallax and proper motion in right ascension (float, Dimensionless[see description])

Correlation coefficient ρ(ϖ,μα*) between parallax and proper motion in right ascension, a dimensionless quantity in the range [-1,+1]

parallax_pmdec_corr : Correlation between parallax and proper motion in declination (float, Dimensionless[see description])

Correlation coefficient ρ(ϖ,μδ) between parallax and proper motion in declination, a dimensionless quantity in the range [-1,+1]

pmra_pmdec_corr : Correlation between proper motion in right ascension and proper motion in declination (float, Dimensionless[see description])

Correlation coefficient ρ(μα*,μδ) between proper motion in right ascension and proper motion in declination, a dimensionless quantity in the range [-1,+1]

astrometric_n_obs_al : Total number of observations AL (short)

Total number of AL observations (= CCD transits) used in the astrometric solution of the source, independent of their weight. Note that some observations may be strongly downweighted (see
astrometric_n_bad_obs_al).

astrometric_n_obs_ac : Total number of observations AC (short)

Total number of AC observations (= CCD transits) used in the astrometric solution of the source, independent of their weight (note that some observations may be strongly downweighted). Nearly all sources having G <13 will have AC observations from 2d windows, while fainter than that limit only 1% of transit observations (the so–called ‘calibration faint stars’) are assigned 2d windows resulting in AC observations.

astrometric_n_good_obs_al : Number of good observations AL (short)

Number of AL observations (= CCD transits) that were not strongly downweighted in the astrometric solution of the source. Strongly downweighted observations (with downweighting factor w<0.2) are instead counted in astrometric_n_bad_obs_al. The sum of astrometric_n_good_obs_al and astrometric_n_bad_obs_al equals
astrometric_n_obs_al, the total number of AL observations used in the astrometric solution of the source.

astrometric_n_bad_obs_al : Number of bad observations AL (short)

Number of AL observations (= CCD transits) that were strongly downweighted in the astrometric solution of the source, and therefore contributed little to the determination of the astrometric parameters. An observation is considered to be strongly downweighted if its downweighting factor w<0.2, which means that the absolute value of the astrometric residual exceeds 4.83 times the total uncertainty of the observation, calculated as the quadratic sum of the centroiding uncertainty, excess source noise, and excess attitude noise.

astrometric_gof_al : Goodness of fit statistic of model wrt along-scan observations (float)

Goodness-of-fit statistic of the astrometric solution for the source in the along-scan direction. This is the ‘gaussianized chi-square’, which for good fits should approximately follow a normal distribution with zero mean value and unit standard deviation. Values exceeding, say, +3 thus indicate a bad fit to the data.

This statistic is computed according to the formula

astrometric_gof_al=(9ν/2)1/2[𝚛𝚞𝚠𝚎2/3+2/(9ν)-1]

where ruwe is the renormalised unit weight error and

ν=astrometric_n_good_obs_al-N

is the number of degrees of freedom for a source update. Here N=5 for 2-parameter and 5-parameter solutions (respectively astrometric_params_solved = 3 or 31) and 6 for 6-parameter solutions (astrometric_params_solved = 95). Note that only ‘good’ (i.e. not strongly downweighted) observations are included in ν. For further details please see Lindegren et al. (2021).

astrometric_chi2_al : AL chi-square value (float)

Astrometric goodness-of-fit (χ2) in the AL direction.

χ2 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.

astrometric_excess_noise : Excess noise of the source (float, Angle[mas])

This is the excess noise ϵi of the source. It measures the disagreement, expressed as an angle, between the observations of a source and the best-fitting standard astrometric model (using five astrometric parameters). The assumed observational noise in each observation is quadratically increased by ϵi in order to statistically match the residuals in the astrometric solution. A value of 0 signifies that the source is astrometrically well-behaved, i.e. that the residuals of the fit statistically agree with the assumed observational noise. A positive value signifies that the residuals are statistically larger than expected.

The significance of ϵi is given by astrometric_excess_noise_sig (D). If D2 then ϵi is probably not significant, and the source may be astrometrically well-behaved even if ϵi is large.

The excess noise ϵi may absorb all kinds of modelling errors that are not accounted for by the observational noise (image centroiding error) or the excess attitude noise. Such modelling errors include LSF and PSF calibration errors, geometric instrument calibration errors, and part of the high-frequency attitude noise. These modelling errors are particularly important in the early data releases, but should decrease as the astrometric modelling of the instrument and attitude improves over the years.

Additionally, sources that deviate from the standard five-parameter astrometric model (e.g. unresolved binaries, exoplanet systems, etc.) may have positive ϵi. Given the many other possible contributions to the excess noise, the user must study the empirical distributions of ϵi and D to make sensible cutoffs before filtering out sources for their particular application.

The excess source noise is further explained in Sects. 3.6 and 5.1.2 of Lindegren et al. (2012).

astrometric_excess_noise_sig : Significance of excess noise (float)

A dimensionless measure (D) of the significance of the calculated astrometric_excess_noise (ϵi). A value D>2 indicates that the given ϵi is probably significant.

For good fits in the limit of a large number of observations, D should be zero in half of the cases and approximately follow the positive half of a normal distribution with zero mean and unit standard deviation for the other half. Consequently, D is expected to be greater than 2 for only a few percent of the sources with well-behaved astrometric solutions.

In the early data releases ϵi will however include instrument and attitude modelling errors that are statistically significant and could result in large values of ϵi and D. The user must study the empirical distributions of these statistics and make sensible cutoffs before filtering out sources for their particular application.

The excess noise significance is further explained in Sect. 5.1.2 of Lindegren et al. (2012).

astrometric_params_solved : Which parameters have been solved for? (byte)

The seven bits of astrometric_params_solved indicate which parameters have been estimated in AGIS for this source. A set bit means the parameter was updated, an unset bit means the parameter was not updated. The least-significant bit corresponds to ra. The table below shows the values of astrometric_params_solved for relevant combinations of the parameters.

The radial proper motion (μr) is formally considered to be one of the astrometric parameters of a source, and the sixth bit is therefore reserved for it. It is also in principle updatable in AGIS, but in practice it will always be computed from a spectroscopic radial velocity and the estimated parallax, in which case the bit is not set.

C is the pseudocolour of the source, i.e. the astrometrically estimated effective wavenumber.

astrometric_params_solved ra dec parallax pmra pmdec μr C
00000112=3
00001112=7
00110112=27
00111112=31
01111112=63
10111112=95

In practice all the sources in DR3 have only values of 3, 31 or 95 for the 𝚊𝚜𝚝𝚛𝚘𝚖𝚎𝚝𝚛𝚒𝚌_𝚙𝚊𝚛𝚊𝚖𝚜_𝚜𝚘𝚕𝚟𝚎𝚍, corresponding to two-parameter (position), five-parameter (position, parallax, and proper motion) and six-parameter (position, parallax, proper motion and astrometrically estimated effective wavenumber) solutions.

astrometric_primary_flag : Primary or seconday (boolean)

Flag indicating if this source was used as a primary source (true) or secondary source (false). Only primary sources contribute to the estimation of attitude, calibration, and global parameters. The estimation of source parameters is otherwise done in exactly the same way for primary and secondary sources.

nu_eff_used_in_astrometry : Effective wavenumber of the source used in the astrometric solution (float, Misc[μm-1])

Effective wavenumber of the source, νeff, in μm-1.

This νeff is the value used in the image parameter determination and in the astrometric calibration if reliable mean BP and RP photometry were available. It is the photon-flux weighted inverse wavelength, as estimated from the BP and RP bands. The field is provided for astrometric solutions with five parameters but is empty for those with two or six parameters.

Due to cyclic processing of the astrometry and the photometry, this effective wavenumber might be different from the one computed using the latest available photometry. Moreover, if no reliable photometry was available at the time of the astrometric processing, this field is empty and an astrometrically estimated value of the effective wavenumber may instead be given in the pseudocolour field.

pseudocolour : Astrometrically estimated pseudocolour of the source (float, Misc[μm-1])

Effective 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, measured in μm-1. The value in this field was estimated from the chromatic displacements of image centroids, calibrated by means of the photometrically determined effective wavenumbers (νeff) of primary sources.

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.

pseudocolour_error : Standard error of the pseudocolour of the source (float, Misc[μm-1])

Standard error σ𝚙𝚜𝚎𝚞𝚍𝚘𝚌𝚘𝚕𝚘𝚞𝚛 of the astrometrically determined pseudocolour of the source.

ra_pseudocolour_corr : Correlation between right ascension and pseudocolour (float, Dimensionless[see description])

Correlation coefficient ρ(α,𝚙𝚜𝚎𝚞𝚍𝚘𝚌𝚘𝚕𝚘𝚞𝚛) between right ascension ra and pseudocolour, a dimensionless quantity in the range [-1,+1]

dec_pseudocolour_corr : Correlation between declination and pseudocolour (float, Dimensionless[see description])

Correlation coefficient ρ(δ,𝚙𝚜𝚎𝚞𝚍𝚘𝚌𝚘𝚕𝚘𝚞𝚛) between declination dec and pseudocolour, a dimensionless quantity in the range [-1,+1]

parallax_pseudocolour_corr : Correlation between parallax and pseudocolour (float, Dimensionless[see description])

Correlation coefficient ρ(ϖ,𝚙𝚜𝚎𝚞𝚍𝚘𝚌𝚘𝚕𝚘𝚞𝚛) between parallax and pseudocolour, a dimensionless quantity in the range [-1,+1]

pmra_pseudocolour_corr : Correlation between proper motion in right asension and pseudocolour (float, Dimensionless[see description])

Correlation coefficient ρ(μα*,𝚙𝚜𝚎𝚞𝚍𝚘𝚌𝚘𝚕𝚘𝚞𝚛) between proper motion in right ascension pmra and pseudocolour, a dimensionless quantity in the range [-1,+1]

pmdec_pseudocolour_corr : Correlation between proper motion in declination and pseudocolour (float, Dimensionless[see description])

Correlation coefficient ρ(μδ,𝚙𝚜𝚎𝚞𝚍𝚘𝚌𝚘𝚕𝚘𝚞𝚛) between proper motion in declination pmdec and pseudocolour, a dimensionless quantity in the range [-1,+1]

astrometric_matched_transits : Matched FOV transits used in the AGIS solution (short)

The number of field–of–view transits matched to this source, counting only the transits containing CCD observations actually used to compute the astrometric solution.

This number will always be equal to or smaller than matched_transits, the difference being the FOV transits that were not used in the astrometric solution because of bad data or excluded time intervals.

visibility_periods_used : Number of visibility periods used in Astrometric solution (short)

Number of visibility periods used in the astrometric solution.

A visibility period is a group of observations separated from other groups by a gap of at least 4 days. A source may have from one to tens of field–of–view transits in a visibility period, but with a small spread in time, direction of scanning, and parallax factor. From one visibility period to the next these variables have usually changed significantly. A high number of visibility periods is therefore a better indicator of an astrometrically well–observed source than a large number of field–of–view transits (matched_transits or astrometric_matched_transits) or CCD observations (astrometric_n_obs_al). A small value (e.g. less than 10) indicates that the calculated parallax could be more vulnerable to errors, e.g. from the calibration model, not reflected in the formal uncertainties. See Lindegren et al. (2018) for a discussion of this and other astrometric quality indicators.

astrometric_sigma5d_max : The longest semi-major axis of the 5-d error ellipsoid (float, Angle[mas])

The longest principal axis in the 5-dimensional error ellipsoid.

This is a 5-dimensional equivalent to the semi-major axis of the position error ellipse and is therefore 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. The matrix is scaled so as to put the five parameters on a comparable scale, taking into account the maximum along-scan parallax factor for the parallax and the time coverage of the observations for the proper motion components. If C is the unscaled covariance matrix, the scaled matrix is SCS, where S=diag(1,1,sinξ,T/2,T/2), ξ=45 is the solar aspect angle in the nominal scanning law, and T the time coverage of the data used in the solution.

astrometric_sigma5d_max is given for all the solutions, as its size is one of the criteria for accepting or rejecting the 5 or 6-parameter solution. In case of a 2- parameter solution (astrometric_params_solved = 3) it gives the value for the rejected 5 or 6-parameter solution, and can then be arbitrarily large.

matched_transits : The number of transits matched to this source (short)

The total number of field–of–view transits matched to this source.

new_matched_transits : The number of transits newly incorporated into an existing source in the current cycle (short)

Individual field–of–view transits are crossmatched into unique sources at the start of each reprocessing cycle taking the source list from the previous cycle as a starting point. During that process a combination of appending, merging and splitting operations is performed to create a more complete and reliable map of unique sources given the available information. Existing individual sources may accrete further transits, may be merged into fewer unique sources, or may split into two or more new, unique sources as more measurements are accumulated. Field new_matched_transits logs the number of transits newly appended to an existing source during the most recent cyclic reprocessing crossmatch. It refers exclusively to the source_id.

matched_transits_removed : The number of transits removed from an existing source in the current cycle (short)

Individual field–of–view transits are crossmatched into unique sources at the start of each reprocessing cycle taking the source list from the previous cycle as a starting point. During that process a combination of appending, merging and splitting operations is performed to create a more complete and reliable map of unique sources given the available information. Existing individual sources may accrete further transits, may be merged into fewer unique sources, or may split into two or more new, unique sources as more measurements are accumulated. Field matched_transits_removed logs the number of transits removed during the most recent cyclic reprocessing crossmatch from those allocated to an existing source during all previous cycles. It refers exclusively to the source_id.

ipd_gof_harmonic_amplitude : Amplitude of the IPD GoF versus position angle of scan (float, Dimensionless[see description])

This statistic measures the amplitude of the variation of the IPD GoF (reduced chi-square) as function of the position angle of the scan direction. A large amplitude indicates that the source is double, in which case the phase indicates the position angle of the pair modulo 180 degrees. The quantity was computed using only transits used in the astrometric solution, for example those without the EPSL and without outliers.

Let ψ be the position angle of the scan direction. The following expression is fitted to the IPD GoF for all the AF observations of the source:

ln(GoF)=c0+c2cos(2ψ)+s2sin(2ψ)

The amplitude and phase of the variation are calculated as

ipd_gof_harmonic_amplitude=c22+s22
ipd_gof_harmonic_phase=12atan2(s2,c2)(+180)

where atan2 returns the angle in degrees, and 180 is added for negative values.

ipd_gof_harmonic_phase : Phase of the IPD GoF versus position angle of scan (float, Angle[deg])

This statistic measures the phase of the variation of the IPD GoF (reduced chi-square) as function of the position angle of the scan direction. The quantity was computed using only transits used in the astrometric solution, for example those without the EPSL and without outliers. See the description of parameter ipd_gof_harmonic_amplitude for further details.

ipd_frac_multi_peak : Percent of successful-IPD windows with more than one peak (byte)

This field provides information on the raw windows used for the astrometric processing of this source coming from the Image Parameters Determination (IPD) module in the core processing. It provides the fraction of windows (having a successful IPD result), as percentage (from 0 to 100), for which the IPD algorithm has identified a double peak, meaning that the detection may be a visually resolved double star (either just visual double or real binary). The quantity was computed using all transits where the IPD was successful.

ipd_frac_odd_win : Percent of transits with truncated windows or multiple gate (byte)

This field is calculated during AGIS and provides information on the raw windows used for the astrometric processing of this source. It provides the fraction (as a percentage, from 0 to 100) of transits having either truncation or multiple gates flagged in one or more windows. Such a situation invariably means that the on-board VPU detected some nearby source (which may be just a spurious detection, but typically could be some real nearby source — having another distinct transit and most probably assigned to a different source). So in general a non–zero fraction indicates that this source may be contaminated by another nearby source. The quantity was computed using all transits where the IPD was successful.

ruwe : Renormalised unit weight error (float)

The Renormalised Unit Weight Error is computed as

𝚛𝚞𝚠𝚎=astrometric_chi2_al/(astrometric_n_good_obs_al-m)f(G,GBP-GRP)

where m is the number of parameters solved (the number of set bits in paramsSolved) and f is a renormalising function.

In practice f is determined in an off-line statistical analysis of the secondary solutions — see for example ‘Re-normalising the astrometric chi-square in Gaia DR2’ (Lindegren 2018). Also note that this value is set to null for sources with only a two-parameter solution, since this value would be difficult to interpret in such cases.

scan_direction_strength_k1 : Degree of concentration of scan directions across the source (float)

The scan_direction_strength_k14 and scan_direction_mean_k14 quantify the distribution of AL scan directions across the source. scan_direction_strength_k1 (and similarly 2,3,4) are the absolute value of the trigonometric moments mk=exp(ikθ) for k=1,2,3,4 where θ is the position angle of the scan and the mean value is taken over the astrometric_n_good_obs_al observations contributing to the astrometric parameters of the source. θ is defined in the usual astronomical sense: θ=0 when the FoV is moving towards local North, and θ=90 towards local East.

N.B. When astrometric_n_obs_ac >0 the scan direction attributes are not provided at Gaia EDR3. Hence for all sources brighter than G 13, and for a tiny fraction of fainter sources (1%), these 8 scan direction fields will be NULL.

The scan_direction_strength_k14 are numbers between 0 and 1, where 0 means that the scan directions are well spread out in different directions, while 1 means that they are concentrated in a single direction (given by the corresponding scan_direction_mean_k14).

The different orders k are statistics of the scan directions modulo 360/k. For example, at first order (k=1), θ=10 and θ=190 count as different directions, but at second order (k=2) they are the same. Thus, scan_direction_strength_k1 is the degree of concentration when the sense of direction is taken into account, while scan_direction_strength_k2 is the degree of concentration without regard to the sense of direction. A large value of scan_direction_strength_k4 indicates that the scans are concentrated in two nearly orthogonal directions.

scan_direction_strength_k2 : Degree of concentration of scan directions across the source (float)

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source.

See the description for attribute scan_direction_strength_k1 for further details.

scan_direction_strength_k3 : Degree of concentration of scan directions across the source (float)

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source.

See the description for attribute scan_direction_strength_k1 for further details.

scan_direction_strength_k4 : Degree of concentration of scan directions across the source (float)

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source.

See the description for attribute scan_direction_strength_k1 for further details.

scan_direction_mean_k1 : Mean position angle of scan directions across the source (float, Angle[deg])

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source. scan_direction_mean_k1 (and similarly for k=2,3,4) is 1/k times the argument of the trigonometric moments mk=exp(ikθ), where θ is the position angle of the scan and the mean value is taken over the astrometric_n_good_obs_al observations contributing to the astrometric parameters of the source. θ is defined in the usual astronomical sense: θ=0 when the FoV is moving towards local North, and θ=90 towards local East.

N.B. When astrometric_n_obs_ac >0 the scan direction attributes are not provided at Gaia EDR3. Hence for all sources brighter than G 13, and for a tiny fraction of fainter sources (1%), these 8 scan direction fields will be NULL.

scan_direction_mean_k1 (and similarly for k=2,3,4) is an angle between -180/k and +180/k, giving the mean position angle of the scans at order k.

The different orders k are statistics of the scan directions modulo 360/k. For example, at first order (k=1), θ=10 and θ=190 count as different directions, but at second order (k=2) they are the same. Thus, scan_direction_mean_k1 is the mean direction when the sense of direction is taken into account, while scan_direction_mean_k2 is the mean direction without regard to the sense of the direction. For example, scan_direction_mean_k1 = 0 means that the scans preferentially go towards North, while scan_direction_mean_k2 = 0 means that they preferentially go in the North-South direction, and scan_direction_mean_k4 = 0 that they preferentially go either in the North-South or in the East-West direction.

scan_direction_mean_k2 : Mean position angle of scan directions across the source (float, Angle[deg])

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source.

See the description for attribute scan_direction_mean_k1 for further details.

scan_direction_mean_k3 : Mean position angle of scan directions across the source (float, Angle[deg])

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source.

See the description for attribute scan_direction_mean_k1 for further details.

scan_direction_mean_k4 : Mean position angle of scan directions across the source (float, Angle[deg])

The scan_direction_strength_k14 and scan_direction_mean_k14 attributes quantify the distribution of AL scan directions across the source.

See the description for attribute scan_direction_mean_k1 for further details.

duplicated_source : Source with multiple source identifiers (boolean)

During data processing, this source happened to be duplicated and only one source identifier has been kept. Observations assigned to the discarded source identifier(s) were not used. This may indicate observational, cross-matching or processing problems, or stellar multiplicity, and probable astrometric or photometric problems in all cases. The duplicity criterion used for Gaia DR3 is an angular distance of 0.18 arcsec, while a limit of 0.4 arcsec was used for Gaia DR2.

phot_g_n_obs : Number of observations contributing to G photometry (short)

Number of observations (CCD transits) that contributed to the G mean flux and mean flux error.

phot_g_mean_flux : G-band mean flux (double, Flux[e-/s])

Mean flux in the G-band.

phot_g_mean_flux_error : Error on G-band mean flux (float, Flux[e-/s])

Standard deviation of the G-band fluxes divided by sqrt(phot_g_n_obs)

phot_g_mean_flux_over_error : G-band mean flux divided by its error (float)

Mean flux in the G-band divided by its error.

phot_g_mean_mag : G-band mean magnitude (float, Magnitude[mag])

Mean magnitude in the G band. This is computed from the G-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. This converts to an asymmetric error distribution in magnitude space which cannot be represented by a single error value.

phot_bp_n_obs : Number of observations contributing to BP photometry (short)

Number of observations (CCD transits) that contributed to the integrated BP mean flux and mean flux error.

phot_bp_mean_flux : Integrated BP mean flux (double, Flux[e-/s])

Mean flux in the integrated BP band.

phot_bp_mean_flux_error : Error on the integrated BP mean flux (float, Flux[e-/s])

Error on the mean flux in the integrated BP band (errors are computed from the dispersion about the weighted mean of input calibrated photometry). A handful of sources have error equal to zero. More details and the list of the sources affected are in Section 5.4.2.

phot_bp_mean_flux_over_error : Integrated BP mean flux divided by its error (float)

Integrated BP mean flux divided by its error. A handful of sources have error equal to zero, meaning that the ratio is NULL. More details and the list of the sources affected are in Section 5.4.2.

phot_bp_mean_mag : Integrated BP mean magnitude (float, Magnitude[mag])

Mean 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. This converts to an asymmetric error distribution in magnitude space which cannot be represented by a single error value.

phot_rp_n_obs : Number of observations contributing to RP photometry (short)

Number of observations (CCD transits) that contributed to the integrated RP mean flux and mean flux error.

phot_rp_mean_flux : Integrated RP mean flux (double, Flux[e-/s])

Mean flux in the integrated RP band.

phot_rp_mean_flux_error : Error on the integrated RP mean flux (float, Flux[e-/s])

Error on the mean flux in the integrated RP band (errors are computed from the dispersion about the weighted mean of input calibrated photometry). A handful of sources have error equal to zero. More details and the list of the sources affected are in Section 5.4.2.

phot_rp_mean_flux_over_error : Integrated RP mean flux divided by its error (float)

Integrated RP mean flux divided by its error. A handful of sources have error equal to zero, meaning that the ratio is NULL. More details and the list of the sources affected are in Section 5.4.2.

phot_rp_mean_mag : Integrated RP mean magnitude (float, Magnitude[mag])

Mean 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. This converts to an asymmetric error distribution in magnitude space which cannot be represented by a single error value.

phot_bp_n_contaminated_transits : Number of BP contaminated transits (short)

Number of BP transits that contributed to the mean photometry and were considered to be contaminated by one or more nearby sources. The contaminating sources may come from the other field of view.

phot_bp_n_blended_transits : Number of BP blended transits (short)

Number of BP transits that contributed to the mean photometry and were flagged to be blends of more than one source (i.e. more than one source is present in the observing window). The blended sources may come from different fields of view.

phot_rp_n_contaminated_transits : Number of RP contaminated transits (short)

Number of RP transits that contributed to the mean photometry and were considered to be contaminated by one or more nearby sources. The contaminating sources may come from the other field of view.

phot_rp_n_blended_transits : Number of RP blended transits (short)

Number of RP transits that contributed to the mean photometry and were flagged to be blends of more than one source (i.e. more than one source is present in the observing window). The blended sources may come from different fields of view.

phot_proc_mode : Photometry processing mode (byte)

This flag indicates the photometric calibration process used for the source. The process is determined by the availability of colour information derived from the internally calibrated mean BP and RP source spectra. The following values are defined for Gaia EDR3:

  • 0: this corresponds to the “gold” photometric dataset. Sources in this dataset have complete colour information.

  • 1: this corresponds to the “silver” photometric dataset. Sources in this dataset have incomplete colour information and therefore were calibrated using an iterative process that estimated the missing colour information from the source mean G and either BP or RP photometry (depending on which band had full colour information available) using empirical relationships derived from the gold dataset.

  • 2: this corresponds to the “bronze” photometric dataset. Sources in this dataset had insufficient colour information and therefore were calibrated using default colour information derived from the gold dataset.

Because the process of generating the mean BP and RP spectra and the process of producing mean BP and RP integrated photometry are very different and have different requirements it is possible for gold sources to be missing any of the bands, i.e. “gold” does not imply anything about the availability of mean G, BP and RP photometry. Similarly for silver and bronze sources it is possible to have photometry available in any bands (and possible combinations).

More details about the different calibration procedures are available in Chapter 5 of the Gaia EDR3 on-line documentation and in Riello et al. (2020)

phot_bp_rp_excess_factor : BP/RP excess factor (float)

BP/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. A deviation from the norm means that there is a consistency issue between the fluxes. This could generally imply a problem with the G, BP or RP measurements. More details on how to best interpret this metric can be found in Riello et al. (2020).

bp_rp : BP - RP colour (float, Magnitude[mag])

BP-RP colour (phot_bp_mean_magphot_rp_mean_mag).

bp_g : BP - G colour (float, Magnitude[mag])

BP-G colour (phot_bp_mean_magphot_g_mean_mag).

g_rp : G - RP colour (float, Magnitude[mag])

G-RP colour (phot_g_mean_magphot_rp_mean_mag).

dr2_radial_velocity : Radial velocity from Gaia DR2 (float, Velocity[km/s] )

Spectroscopic radial velocity in the solar barycentric reference frame. The radial velocity provided is the median value of the radial velocity measurements at all epochs. At Gaia EDR3 this value is simply that copied in from Gaia DR2. The Gaia DR2 values are assigned to the Gaia EDR3 sources through an internal cross-match operation and about 11000 sources could not be matched. In addition about 4000 identified spurious radial velocities are not copied. For further details see Section 6.1.1 in the online documentation for the release.

dr2_radial_velocity_error : Radial velocity error from Gaia DR2 (float, Velocity[km/s] )

The dr2_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. At Gaia EDR3 this column is simply that copied in from Gaia DR2. The Gaia DR2 radial velocities and associated quantities are assigned to the Gaia EDR3 sources through an internal cross-match operation and about 11000 sources could not be matched. In addition about 4000 identified spurious radial velocities, along with their associated values, are not copied. For further details see Section 6.1.1 in the online documentation for the release.

In detail, dr2_radial_velocity_error = σVrad2+0.112 where σVrad is the error on the median:

σVrad=π2.σ(Vradt)dr2_rv_nb_transits

where σ(Vradt) is the standard deviation of the epoch radial velocities and dr2_rv_nb_transits the number of transits for which a Vradt has been obtained.

dr2_rv_nb_transits : Number of transits used to compute radial velocity in Gaia DR2 (short)

The number of transits (epochs) used to compute dr2_radial_velocity. At Gaia EDR3 this value is simply that copied in from Gaia DR2. The Gaia DR2 radial velocities and associated quantities are assigned to the Gaia EDR3 sources through an internal cross-match operation and about 11000 sources could not be matched. In addition about 4000 identified spurious radial velocities, along with their associated values, are not copied. For further details see Section 6.1.1 in the online documentation for the release.

dr2_rv_template_teff : Teff of the template used to compute radial velocity in Gaia DR2 (float, Temperature[K])

Effective temperature of the synthetic spectrum template used to determine dr2_radial_velocity. N.B. the purpose of this parameter is to provide information on the synthetic template spectrum used to determine dr2_radial_velocity, and not to provide an estimate of the stellar effective temperature of this source.

At Gaia EDR3 this value is simply that copied in from Gaia DR2. The Gaia DR2 radial velocities and associated quantities are assigned to the Gaia EDR3 sources through an internal cross-match operation and about 11000 sources could not be matched. In addition about 4000 identified spurious radial velocities, along with their associated values, are not copied. For further details see Section 6.1.1 in the online documentation for the release.

dr2_rv_template_logg : logg of the template used to compute radial velocity in Gaia DR2 (float, GravitySurface[log cgs])

logg of the synthetic spectrum template used to determine dr2_radial_velocity. N.B. the purpose of this parameter is to provide information on the synthetic template spectrum used to determine dr2_radial_velocity, and not to provide an estimate of the logg of this source.

At Gaia EDR3 this value is simply that copied in from Gaia DR2. The Gaia DR2 radial velocities and associated quantities are assigned to the Gaia EDR3 sources through an internal cross-match operation and about 11000 sources could not be matched. In addition about 4000 identified spurious radial velocities, along with their associated values, are not copied. For further details see Section 6.1.1 in the online documentation for the release.

dr2_rv_template_fe_h : Fe/H of the template used to compute radial velocity in Gaia DR2 (float, Abundances[dex])

Fe/H of the synthetic spectrum template used to determine dr2_radial_velocity. N.B. the purpose of this parameter is to provide information on the synthetic template spectrum used to determine dr2_radial_velocity, and not to provide an estimate of the stellar atmospheric Fe/H of this source.

At Gaia EDR3 this value is simply that copied in from Gaia DR2. The Gaia DR2 radial velocities and associated quantities are assigned to the Gaia EDR3 sources through an internal cross-match operation and about 11000 sources could not be matched. In addition about 4000 identified spurious radial velocities, along with their associated values, are not copied. For further details see Section 6.1.1 in the online documentation for the release.

l : Galactic longitude (double, Angle[deg])

Galactic Longitude of the object at reference epoch ref_epoch, see Section 4.1.7 of the release documentation for conversion details.

b : Galactic latitude (double, Angle[deg])

Galactic Latitude of the object at reference epoch ref_epoch, see Section 4.1.7 of the release documentation for conversion details.

ecl_lon : Ecliptic longitude (double, Angle[deg])

Ecliptic Longitude of the object at reference epoch ref_epoch, obtained from the equatorial coordinates using the transformation defined in Volume 1, Section 1.5.3 of ESA (1997).

Note that in the transformation applied here the ICRS origin is shifted in the equatorial plane from Γ by ϕ=0.05542 arcsec, positive from Γ to the ICRS origin (Chapront et al. 2002). The ICRS has an unambiguous definition with an origin in the ICRF equator defined by the realisation of the ICRF. The ecliptic system is less well-defined, potentially depending on additional conventions in dynamical theories. The transformation employed here corresponds to the inertial mean ecliptic with obliquity and Γ defined by reference to the ICRS equator. Both the obliquity and the position of Γ on the ICRS equator with respect to the ICRS origin have been obtained from Lunar Laser Ranging measurements. This has no time dependence – there is no secular variation of the obliquity and no precession – and it simply defines the relative situation of the various planes at J2000.

ecl_lat : Ecliptic latitude (double, Angle[deg])

Ecliptic Latitude of the object at reference epoch ref_epoch. For further details see the description for attribute ecl_lon.