Introduction, downloads

S: 11 Dec 2023 (b7.2)

D: 11 Dec 2023

Recent version history

What's new?

Future development

Limitations

Note to testers

[Jump to search box]

General usage

Getting started

Citation instructions

Standard data input

PLINK 1 binary (.bed)

Autoconversion behavior

PLINK text (.ped, .tped...)

VCF (.vcf[.gz], .bcf)

Oxford (.gen[.gz], .bgen)

23andMe text

Generate random

Unusual chromosome IDs

Recombination map

Allele frequencies

Phenotypes

Covariates

Clusters of samples

Variant sets

Binary distance matrix

IBD report (.genome)

Input filtering

Sample ID file

Variant ID file

Positional ranges file

Cluster membership

Set membership

Attribute-based

Chromosomes

SNPs only

Simple variant window

Multiple variant ranges

Sample/variant thinning

Covariates (--filter)

Missing genotypes

Missing phenotypes

Minor allele frequencies

Hardy-Weinberg

Mendel errors

Quality scores

Relationships

Main functions

Data management

--make-bed

--recode

--output-chr

--zero-cluster

--split-x/--merge-x

--set-me-missing

--fill-missing-a2

--set-missing-var-ids

--update-map...

--update-ids...

--flip

--flip-scan

--keep-allele-order...

--indiv-sort

--write-covar...

--[b]merge...

Merge failures

VCF reference merge

--merge-list

--write-snplist

--list-duplicate-vars

Basic statistics

--freq[x]

--missing

--test-mishap

--hardy

--mendel

--het/--ibc

--check-sex/--impute-sex

--fst

Linkage disequilibrium

--indep...

--r/--r2

--show-tags

--blocks

Distance matrices

Identity-by-state/Hamming

  (--distance...)

Relationship/covariance

  (--make-grm-bin...)

--rel-cutoff

Distance-pheno. analysis

  (--ibs-test...)

Identity-by-descent

--genome

--homozyg...

Population stratification

--cluster

--pca

--mds-plot

--neighbour

Association analysis

Basic case/control

  (--assoc, --model)

Stratified case/control

  (--mh, --mh2, --homog)

Quantitative trait

  (--assoc, --gxe)

Regression w/ covariates

  (--linear, --logistic)

--dosage

--lasso

--test-missing

Monte Carlo permutation

Set-based tests

REML additive heritability

Family-based association

--tdt

--dfam

--qfam...

--tucc

Report postprocessing

--annotate

--clump

--gene-report

--meta-analysis

Epistasis

--fast-epistasis

--epistasis

--twolocus

Allelic scoring (--score)

R plugins (--R)

Secondary input

GCTA matrix (.grm.bin...)

Distributed computation

Command-line help

Miscellaneous

Tabs vs. spaces

Flag/parameter reuse

System resource usage

Pseudorandom numbers

Resources

1000 Genomes

Teaching materials

Gene range lists

Functional SNP attributes

Errors and warnings

Output file list

Order of operations

For developers

GitHub repository

Compilation

Core algorithms

Partial sum lookup

Bit population count

Ternary dot product

Vertical population count

Exact statistical tests

Multithreaded gzip

Adding new functionality

Google groups

plink2-users

plink2-dev

Credits

File formats

Quick index search

File format reference

This page describes specialized PLINK input and output file formats which are identifiable by file extension. (Most extensions not listed here have very simple one-entry-per-line text formats.)

Jump to: .adjusted | .allele.no.snp | .assoc | .assoc.dosage | .assoc.fisher | .assoc.linear | .assoc.logistic | .auto.R | .bcf | .beagle.dat | .bed | .bim | .blocks* | .chr-*.dat | .chr-*.map | .clst | .clumped* | .cluster* | .cmh | .cmh2 | .cnv | .cnv.indiv | .cnv.overlap | .cnv.summary | .cov | .dfam | .diff | .dist | .dupvar | .eigenvec* | .epi.* | .fam | .flipscan | .frq | .frq.cc | .frq.count | .frq.strat | .frqx | .fst | .gen | .genome | .grm | .grm.N.bin | .grm.bin | .gvar | .het | .hh | .hom | .hom.indiv | .hom.overlap* | .hom.summary | .homog | .hwe | .ibc | .imiss | .info | .lasso | .ld | .ldset | .lgen | .list | .lmiss | .map | .mdist | .mdist.missing | .mds | .*mendel | .meta | .mibs | .missing | .missing.hap | .model | .mperm | .nearest | .occur.dosage | .out.dosage | .ped | .perm | .pphe | .prob | .profile | .qassoc | .qassoc.gxe | .qassoc.means | .qfam.* | .range.report | .raw | .recode.*.txt | .recode.phase.inp | .recode.strct_in | .ref | .rel | .rlist | .sample | .set | .set.{perm|mperm} | .set.table | .sexcheck | .simfreq | .tags.list | .tdt | .tdt.poo | .tfam | .tped | .traw | .twolocus | .var.ranges | .vcf

.*.adjusted (basic multiple-testing corrections)

Produced by --adjust.

A text file with a header line, and then one line per set or polymorphic variant with the following 8-11 fields:

CHRChromosome code. Not present with set tests.
'SNP'/'SET'Variant/set identifier
UNADJUnadjusted p-value
GCDevlin & Roeder (1999) genomic control corrected p-value. Requires an additive model.
QQP-value quantile. Only present with 'qq-plot' modifier.
BONFBonferroni correction
HOLMHolm-Bonferroni (1979) adjusted p-value
SIDAK_SSŠidák single-step adjusted p-value
SIDAK_SDŠidák step-down adjusted p-value
FDR_BHBenjamini & Hochberg (1995) step-up false discovery control
FDR_BYBenjamini & Yekutieli (2001) step-up false discovery control

Variants/sets are sorted in p-value order. (As a result, if the QQ field is present, its values just increase linearly.)

.allele.no.snp (allele mismatch report)

Produced by --update-alleles when there is a mismatch between the loaded alleles for a variant and columns 2-3 of the --update-alleles input file.

A text file with no header line, and one line per mismatching variant with the following three fields:

  1. Variant identifier
  2. Expected allele #1 (from --update-alleles input file)
  3. Expected allele #2
.assoc, .assoc.fisher (case/control association allelic test report)

Produced by --assoc acting on a case/control phenotype.

A text file with a header line, and then one line per variant typically with the following 9-10 fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
A1Allele 1 (usually minor)
F_AAllele 1 frequency among cases
F_UAllele 1 frequency among controls
A2Allele 2
CHISQAllelic test chi-square statistic. Not present with 'fisher'/'fisher-midp' modifier.
PAllelic test p-value
ORodds(allele 1 | case) / odds(allele 1 | control)

If the 'counts' modifier is present, the 5th and 6th fields are replaced with:

C_AAllele 1 count among cases
C_UAllele 1 count among controls

If --ci 0.xy has also been specified, there are three additional fields at the end:

SEStandard error of odds ratio estimate
LxyBottom of xy% symmetric approx. confidence interval for odds ratio
UxyTop of xy% approx. confidence interval for odds ratio
.assoc.dosage (dosage association analysis report)

Produced by --dosage.

A text file with a header line, and then usually one line per variant with the following 8-10 fields:

CHRChromosome code. Requires --map.
SNPVariant identifier.
BPBase-pair coordinate. Requires --map.
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
FRQAllele 1 frequency
INFOR-squared quality metric/information content
'BETA'/'OR'Regression coefficient (for quantitative traits) or odds ratio
SEStandard error of effect (not odds ratio) estimate
PAssociation test p-value

If the 'case-control-freqs' modifier is present, the FRQ column is replaced with FRQ_A and FRQ_U columns reporting case and control frequencies, respectively, and NCHROBS will not include missing-phenotype samples. (Unless the phenotype is quantitative instead of case/control; then phenotypes are ignored and FRQ_A and FRQ_U are both equal to the overall FRQ value.)

.assoc.linear, .assoc.logistic (multi-covariate association analysis report)

Produced by --linear/--logistic.

A text file with a header line, and T lines per variant typically with the following nine fields (where T is normally the number of terms, but the 'genotypic' and 'hethom' modifiers and the --tests flag can change this):

CHRChromosome code. Not present with 'no-snp' modifier.
SNPVariant identifier. Not present with 'no-snp'.
BPBase-pair coordinate. Not present with 'no-snp'.
A1Allele 1 (usually minor). Not present with 'no-snp'.
TESTTest identifier
NMISSNumber of observations (nonmissing genotype, phenotype, and covariates)
'BETA'/'OR'Regression coefficient (--linear, "--logistic beta") or odds ratio (--logistic without 'beta')
STATT-statistic
PAsymptotic p-value for t-statistic

If --ci 0.xy has also been specified, the following three fields are inserted before 'STAT':

SEStandard error of beta (log-odds) estimate
LxyBottom of xy% symmetric approx. confidence interval
UxyTop of xy% approx. confidence interval

Refer to the PLINK 1.07 documentation for more details.

.auto.R (R plugin function results)

Produced by --R.

A text file with no header line, and one line per variant, each with at least four fields. The first four are:

  1. Chromosome code
  2. Variant identifier
  3. Base-pair coordinate
  4. Allele 1 (corresponding to allele counts in GENO matrix; usually minor)

Subsequent fields are defined by the plugin function. Lines are permitted to contain different numbers of fields.

.bcf (1000 Genomes Project binary Variant Call Format, version 2)

Variant information + sample ID + genotype call binary file, loaded with --bcf. Cannot currently be generated by PLINK; use "--recode vcf{,-fid,-iid}" to produce a VCF file for now.

The specification for this format is at https://github.com/samtools/hts-specs.

.beagle.dat, .chr-*.dat, .chr-*.map (BEAGLE unphased genotype and variant information files)

Produced by "--recode beagle[-nomap]", for use by BEAGLE. In 'beagle' mode, one file pair is generated per autosome, while in 'beagle-nomap' mode, a single .beagle.dat file is generated containing all autosomes. This format cannot be loaded by PLINK.

Each .dat file produced by PLINK is a text file with three header lines, followed by one line per variant with 2N+2 fields where N is the number of samples:

1st header line2nd header line3rd header lineSubsequent contents
'P''I''A' for C/C pheno., 'T' for scalar'M'
'FID''IID''PHE'Variant identifier
FIDs, 2x per sample...IIDs, 2x per samplePhenotypes, 2x per sampleAllele calls (unphased)

Each .chr-*.map file produced by PLINK is a text file with no header line, and one line per variant with the following four fields:

  1. Variant identifier
  2. Base-pair coordinate
  3. Allele 1 (usually minor), 'X' if absent
  4. Allele 2 (usually major), 'X' if absent
.bed (PLINK binary biallelic genotype table)

Primary representation of genotype calls at biallelic variants. Must be accompanied by .bim and .fam files. Loaded with --bfile; generated in many situations, most notably when the --make-bed command is used. Do not confuse this with the UCSC Genome Browser's BED format, which is totally different.

The first three bytes should be 0x6c, 0x1b, and 0x01 in that order. (There are old versions of the .bed format which start with a different "magic number"; PLINK 1.9 recognizes them, but will convert sample-major files to the current variant-major format on sight. See the bottom of the original .bed definition page for details; that page also contains a more verbose version of the discussion below.)

The rest of the file is a sequence of V blocks of N/4 (rounded up) bytes each, where V is the number of variants and N is the number of samples. The first block corresponds to the first marker in the .bim file, etc.

The low-order two bits of a block's first byte store the first sample's genotype code. ("First sample" here means the first sample listed in the accompanying .fam file.) The next two bits store the second sample's genotype code, and so on for the 3rd and 4th samples. The second byte stores genotype codes for the 5th-8th samples, the third byte stores codes for the 9th-12th, etc.

The two-bit genotype codes have the following meanings:

00Homozygous for first allele in .bim file
01Missing genotype
10Heterozygous
11Homozygous for second allele in .bim file

If N is not divisible by four, the extra high-order bits in the last byte of each block are always zero.

For example, consider the following text fileset:

test.ped:
  1 1 0 0 1  0  G G  2 2  C C
  1 2 0 0 2  0  A A  0 0  A C
  1 3 1 2 1  2  0 0  1 2  A C
  2 1 0 0 1  0  A A  2 2  0 0
  2 2 0 0 2  2  A A  2 2  0 0
  2 3 1 2 1  2  A A  2 2  A A

test.map:
  1 snp1 0 1
  1 snp2 0 2
  1 snp3 0 3

If you load it in PLINK 1.9, a .bed file containing the following sequence of bytes will be autogenerated (you can view it with e.g. Unix xxd):

  0x6c 0x1b 0x01 0xdc 0x0f 0xe7 0x0f 0x6b 0x01

and the following .bim file will accompany it:

  1  snp1  0  1  G  A
  1  snp2  0  2  1  2
  1  snp3  0  3  A  C

(For brevity, we don't reproduce the .fam here.) We can decompose the .bed file as follows:

  • The first three bytes are the magic number.
  • Since there are six samples, each marker block has size 2 bytes (six divided by four, rounded up). Thus genotype data for the first marker ('snp1') is stored in the 4th and 5th bytes.
  • The 4th byte value of 0xdc is 11011100 in binary. Since the low-order two bits are '00', the first sample is homozygous for the first allele for this marker listed in the .bim file, which is 'G'. The second sample has genotype code '11', which means she's homozygous for the second allele ('A'). The third sample's code of '01' designates a missing genotype call, and the fourth code of '11' indicates another AA.
  • The 5th byte value of 0x0f is 00001111 in binary. This indicates that the fifth and sixth samples also have the AA genotype at snp1. There is no sample #7 or #8, so the high-order 4 bits of this byte are zero.
  • The 6th and 7th bytes store genotype data for the second marker ('snp2'). The 6th byte value of 0xe7 is 11100111 in binary. The '11' code for the first sample means that he's homozygous for the second snp2 allele ('2'), the '01' code for the second sample indicates a missing call, the '10' code for the third indicates a heterozygous genotype, and '11' for the fourth indicates another homozygous '2'. The 7th byte value of 0x0f indicates that the fifth and sixth samples also have homozygous '2' genotypes.
  • Finally, the 8th and 9th bytes store genotype data for the third marker ('snp3'). You can test your understanding of the file format by interpreting this by hand and then comparing to the .ped file above.
.bim (PLINK extended MAP file)

Extended variant information file accompanying a .bed binary genotype table. (--make-just-bim can be used to update just this file.)

A text file with no header line, and one line per variant with the following six fields:

  1. Chromosome code (either an integer, or 'X'/'Y'/'XY'/'MT'; '0' indicates unknown) or name
  2. Variant identifier
  3. Position in morgans or centimorgans (safe to use dummy value of '0')
  4. Base-pair coordinate (1-based; limited to 231-2)
  5. Allele 1 (corresponding to clear bits in .bed; usually minor)
  6. Allele 2 (corresponding to set bits in .bed; usually major)

Allele codes can contain more than one character. Variants with negative bp coordinates are ignored by PLINK.

.blocks, .blocks.det (haplotype blocks, estimated using Haploview's default algorithm)

Produced by --blocks.

.blocks files contain one line per block, each with an asterisk followed by variant IDs.

.blocks.det files have a header line, followed by one line per block with the following six fields:

CHRChromosome code
BP1First base-pair coordinate
BP2Last base-pair coordinate
KBBlock length in kbs
NSNPSNumber of variants in block
SNPS'|'-delimited variant IDs
.clst (cluster membership file)

Produced by --write-cluster. Valid input for --within.

A text file with no header line, and one line per sample with the following three fields:

  1. Family ID
  2. Within-family ID
  3. Cluster name

Samples may not appear more than once.

.clumped, .clumped.best, .clumped.ranges (reprocessed LD-clumped reports)

Produced by --clump.

The .clumped file normally has one header line, followed by one line per index variant (lowest p-values first) with the following 11-12 fields:

CHRChromosome code
F1-based file number
SNPIndex variant identifier
BPBase-pair coordinate
PIndex variant p-value
TOTALNumber of other variants in clump
NSIGNumber of clumped variants with p ≥ .05
S05Number of clumped variants with .01 ≤ p < .05
S01Number of clumped variants with .001 ≤ p < .01
S001Number of clumped variants with .0001 ≤ p < .001
S0001Number of clumped variants with p < .0001
SP2Comma-delimited IDs and file numbers of members with p < --clump-p2 threshold. Not present with --clump-verbose.

With --clump-verbose, the header line above is repeated for every clump, instead of just appearing once, and dashed line dividers are present between clumps. Also, each nonempty clump has its own subsection, with the different header line below, one line corresponding to the index variant (with '(INDEX)' before the variant ID), a blank line, and then one line for each other clump member with the following 6-7 fields:

(blank)Variant identifier
KB[current variant bp coordinate] - [index bp coordinate], signed
RSQSquared correlation coefficient with index variant
ALLELESMinor allele for index variant, more-common-than-expected haplotypes otherwise
F1-based file number
PP-value
ANNOTComma-delimited extra fields. Requires --clump-annotate.

Each nonempty clump also has the following 2-3 footer lines:

  1. 'RANGE:', followed by 'chr<#>:<bp1>..<bp2>' (including --clump-range-border padding)
  2. 'SPAN:', followed by range length in kbs
  3. "GENES w/SNPs:", followed by names of regions containing at least one variant in the clump (only present with --clump-range)

Finally, with --clump-range + --clump-verbose, there is a final footer line starting with 'GENES:', followed by names of regions physically overlapping the clump. (This is reported even for empty clumps.)

If --clump-range is used without --clump-verbose, region overlaps are reported in a separate .clumped.ranges file instead. This has a header line, followed by one line per clump with the following seven fields:

CHRChromosome code
SNPIndex variant identifier
PIndex variant p-value
NNumber of variants in clump (including index variant)
POSBase-pair range, as 'chr<#>:<bp1>..<bp2>' (including --clump-range-border padding)
KBRange length in kbs (i.e. (<bp2> - <bp1> + 1) / 1000)
RANGESComma-delimited names of overlapped --clump-range regions, in brackets

Finally, if --clump-best is specified, a .clumped.best file is generated. This has a header line, followed by one line per clump with the following 7-8 fields:

INDEXIndex variant identifier
PSNPID of best proxy (maximum r-squared), or 'NA' if there is none
RSQSquared correlation coefficient between index and proxy
KB<proxy bp coordinate> - <index bp coordinate>, signed
PProxy p-value
ALLELESMore-common-than-expected haplotypes
FProxy file number
(blank)Comma-delimited extra fields for proxy variant. Requires --clump-annotate.
.cluster1, .cluster2, .cluster3, .cluster3.missing (hierarchical clustering reports)

--cluster normally generates three files, with the extensions .cluster1, .cluster2, and .cluster3[.missing]. The .cluster2 file shares the .clst format, so it is valid input for --within. The other two files are also text files with no header line.

.cluster1 files contain one line per cluster, with a cluster name in front ('SOL-0', 'SOL-1', ...), followed by IDs of the cluster's members (formatted as FID + '_' + IID + possibly case/control status in parentheses).

.cluster3[.missing] files contain one line per sample, with their FID and IID as the first two fields (not merged with an underscore here), followed by a sequence of nonnegative integers representing the sample's cluster assignment at each stage of the clustering process.

.cmh (Cochran-Mantel-Haenszel 2x2xK test report)

Produced by --mh/--bd.

A text file with a header line, and then one line per variant with the following 12-14 fields (where 0.xy is the --ci parameter, or 0.95 if none was specified):

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
A1Allele 1 (usually minor)
MAFAllele 1 frequency
A2Allele 2 (usually major)
CHISQCochran-Mantel-Haenszel statistic (1df)
PAsymptotic p-value for CMH test statistic
ORCMH odds ratio
SEStandard error of odds ratio estimate
LxyBottom of xy% symmetric approx. confidence interval
HxyTop of xy% approx. confidence interval
CHISQ_BDBreslow-Day test statistic. Requires --bd.
P_BDAsymptotic p-value for Breslow-Day test statistic. Requires --bd.
.cmh2 (Cochran-Mantel-Haenszel IxJxK test report)

Produced by --mh2.

A text file with a header line, and then one line per variant with the following five fields:

CHRChromosome code
SNPVariant identifier
CHISQCochran-Mantel-Haenszel IxJxK test statistic
DFChi-square degrees of freedom
PAsymptotic p-value

(DF was not directly reported by PLINK 1.07.)

.cnv (segmental copy number variant data)

Produced by postprocessing the output of Birdsuite or a similar package. Loaded with --cnv-list/--cfile. Must be accompanied by a .fam file.

A text file with an optional header line, and one line per segmental call with the following eight fields:

FIDFamily ID
IIDWithin-family ID
CHRChromosome code
BP1First base-pair coordinate
BP2Last base-pair coordinate
TYPENumber of copies of variant
SCOREConfidence score associated with variant (safe to use dummy value of '0')
SITESNumber of probes in the variant (safe to use dummy value of '0')
.cnv.indiv (per-sample segment summary)

Produced whenever --cfile/--cnv-list loading completes.

A text file with a header line, and one line per sample with the following 6-7 fields:

FIDFamily ID
IIDWithin-family ID
PHEPhenotype
NSEGNumber of segments that sample has
KBTotal kilobase distance spanned by segments
KBAVGAverage segment size
COUNT(Only present with --cnv-count, which is not yet implemented.)
.cnv.overlap (overlapping CNV segment report)

Produced by --cnv-check-no-overlap.

A text file with a header line, and one line per overlap with the following five fields:

FIDFamily ID
IIDWithin-family ID
CHRChromosome code
BP1Segment start (base-pair units)
BP2Segment end
.cnv.summary (per-variant CNV summary)

Produced whenever --cfile/--cnv-list loading completes.

A text file with a header line, and one line per variant with the following five fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
AFFCNV count at variant, all cases
UNAFFCNV count at variant, all controls
.cov (covariate table)

Produced by --write-covar, --make-bed, and --recode when an input covariate table has been named with --covar. Valid input for --covar.

A text file with a header line, and one line per sample with the following 2+C or 6+C fields (where C is the number of covariates):

FIDFamily ID
IIDWithin-family ID
PATPaternal within-family ID. Requires --with-phenotype without 'no-parents'.
MATMaternal within-family ID. Requires --with-phenotype without 'no-parents'.
SEXSex. Requires --with-phenotype without 'no-sex'.
PHENOTYPEMain phenotype value. Only present with --with-phenotype.
Covariate IDs...Covariate values

Note that --covar can also be used with files lacking a header row.

.dfam (sib-TDT association report)

Produced by --dfam.

A text file with a header line, and then one line per variant with the following eight fields:

CHRChromosome code
SNPVariant identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
OBSNumber of observed A1 alleles
EXPExpected number of A1 alleles
CHISQSib-TDT test statistic
PAsymptotic p-value for sib-TDT test statistic
.diff (merge conflict report)

Produced by --merge/--bmerge + --merge-mode 6 or 7.

A text file with a header line, and then one line per conflict with the following five fields:

SNPVariant identifier
FIDFamily ID
IIDWithin-family ID
NEWGenotype in merge fileset (named in --merge/--bmerge)
OLDGenotype in reference fileset (loaded with e.g. --bfile)
.dist (genomic Hamming distance matrix)

Produced by --distance.

A tab-delimited text file that is either lower-triangular (first line has only one entry containing the <genome 1-genome 2> Hamming distance, second line has two entries containing the <genome 1-genome 3> and <genome 2-genome 3> Hamming distances in that order, etc.) or square. If square, the upper-right triangle may be either zeroed out or the mirror-image of the lower-left triangle, depending on whether the 'square0' or 'square' modifier was used.

When missing values are present, the affected raw Hamming distances are rescaled to be comparable to pairwise distances unaffected by missing data.

.dupvar (duplicate-position-and-alleles variant report)

Produced by --list-duplicate-vars.

Normally a tab-delimited text file with a header line, followed by one line per duplicate variant group with the following 4 columns:

CHRChromosome code
POSBase-pair coordinate
ALLELESComma-separated allele codes
IDSSpace-separated variant IDs

With the 'ids-only' modifier, the header and the position/allele columns are omitted; only space-delimited lists of variant IDs remain. (This form is directly usable with --extract/--exclude.)

With 'require-same-ref' (and without 'ids-only'), the ALLELES column is replaced with the following two columns:

REFA2 allele
ALTA1 allele (will become a comma-separated list in PLINK 2.0)
.eigenvec, .eigenvec.var (principal components)

Produced by --pca. Accompanied by an .eigenval file, which contains one eigenvalue per line.

The .eigenvec file is, by default, a space-delimited text file with no header line and 2+V columns per sample, where V is the number of requested principal components. The --pca 'header' modifier causes a header line to be written, and the 'tabs' modifier makes this file tab-delimited. The first two columns are the sample's FID/IID, and the rest are principal component scores in the same order as the .eigenval values (if the header line is present, these columns are titled 'PC1', 'PC2', ...).

With the 'var-wts' modifier, an .eigenvec.var file is also generated. It replaces the FID/IID columns with 'CHR', 'VAR', 'A1', and 'A2' columns containing chromosome codes, variant IDs, A1 alleles, and A2 alleles, respectively; otherwise the formats are identical.

.epi.{cc,co,qt}, .epi.{cc,co,qt}.summary (epistatic interaction scan reports)

Produced by --epistasis and --fast-epistasis. 'cc' secondary extension indicates a case/control test, 'co' indicates "--fast-epistasis case-only", and 'qt' indicates --epistasis linear regression on a quantitative trait.

The main report is normally a text file with a header line, followed by one line per variant pair clearing the --epi1 threshold with the following 5-7 fields:

CHR1Variant 1 chromosome code
SNP1Variant 1 identifier
CHR2Variant 2 chromosome code
SNP2Variant 2 identifier
'OR_INT'/'BETA_INT'Odds ratio (case/control) or regression coefficient (QT). Requires --epistasis.
STATChi-square statistic
DFChi-square degrees of freedom. Only present with 'boost'.
PChi-square p-value. Not present with --fast-epistasis 'nop' modifier.

The .summary file is a text file with a header line, followed by one line per variant (or just one line per variant in set #1, if 'set-by-set' or 'set-by-all' was specified) with the following 7-8 fields:

CHRChromosome code
SNPVariant identifier
N_SIGNumber of 'significant' (based on --epi2 value) epistatic test results
N_TOTTotal number of valid test results
PROPProportion significant. Not always present in intermediate --parallel files.
BEST_CHISQLargest chi-square statistic (approximate when 'boost' test and ≤ --epi1 threshold)
BEST_CHRChromosome of largest-statistic variant
BEST_SNPID of largest-statistic variant

For the 'boost' test, the BEST_CHISQ/BEST_CHR/BEST_SNP entry occasionally doesn't correspond to lowest p-value, since DF is variable.

For two-set tests, if variant v1 is in both sets but v2 is only in set #1, the v1-v2 test is only counted in the v2 summary row. (This is a change from PLINK 1.07.)

.fam (PLINK sample information file)

Sample information file accompanying a .bed binary genotype table. (--make-just-fam can be used to update just this file.) Also generated by "--recode lgen" and "--recode rlist".

A text file with no header line, and one line per sample with the following six fields:

  1. Family ID ('FID')
  2. Within-family ID ('IID'; cannot be '0')
  3. Within-family ID of father ('0' if father isn't in dataset)
  4. Within-family ID of mother ('0' if mother isn't in dataset)
  5. Sex code ('1' = male, '2' = female, '0' = unknown)
  6. Phenotype value ('1' = control, '2' = case, '-9'/'0'/non-numeric = missing data if case/control)

With the use of additional loading flag(s), PLINK can also correctly interpret some .fam files missing one or more of these fields.

If there are any numeric phenotype values other than {-9, 0, 1, 2}, the phenotype is interpreted as a quantitative trait instead of case/control status. In this case, -9 normally still designates a missing phenotype; use --missing-phenotype if this is problematic.

Several PLINK commands (e.g. --cluster) merge the FID and IID with an underscore in their reports; for example, a sample with FID = 'Chang' and IID = 'Christopher' would be referenced as 'Chang_Christopher'. We preserve this behavior for backwards compatibility, so you should avoid using underscores in FIDs and IIDs (consider '~' instead).

If your case/control phenotype is encoded as '0' = control and '1' = case, you'll need to specify --1 to load it properly.

.flipscan, .flipscan.verbose (case/control strand inconsistency report)

Produced by --flip-scan.

The .flipscan file is a text file with a header line, and one line per variant with the following 11 fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
FAllele 1 frequency
POSNumber of positive LD matches
R_POSPositive LD match average correlation
NEGNumber of negative LD matches
R_NEGNegative LD match average correlation
NEGSNPSNegative LD match ID(s), '|'-delimited

If the 'verbose' modifier is present, a .flipscan.verbose file is also generated. This is a text file with a header line, and one line per relevant variant pair (i.e. index variant has at least one negative LD match, and case and/or control correlation has sufficient absolute value) with the following nine fields:

CHR_INDXChromosome code
SNP_INDXIndex variant identifier
BP_INDXIndex variant base-pair coordinate
A1_INDXIndex variant allele 1
SNP_PAIRSecond variant identifier
BP_PAIRSecond variant base-pair coordinate
A1_PAIRSecond variant allele 1
R_ACase-only correlation
R_UControl-only correlation
.frq (basic allele frequency report)

Produced by --freq. Valid input for --read-freq.

A text file with a header line, and then one line per variant with the following six fields:

CHRChromosome code
SNPVariant identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
MAFAllele 1 frequency
NCHROBSNumber of allele observations
.frq.cc (case/control phenotype-stratified allele frequency report)

Produced by "--freq case-control". Not valid input for --read-freq.

A text file with a header line, and then one line per variant with the following eight fields:

CHRChromosome code
SNPVariant identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
MAF_AAllele 1 frequency in cases
MAF_UAllele 1 frequency in controls
NCHROBS_ANumber of case allele observations
NCHROBS_UNumber of control allele observations
.frq.count (basic allele count report)

Produced by "--freq counts". Valid input for --read-freq.

A text file with a header line, and then one line per variant with the following seven fields:

CHRChromosome code
SNPVariant identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
C1Allele 1 count
C2Allele 2 count
G0Missing genotype count (so C1 + C2 + 2 * G0 is constant on autosomal variants)
.frq.strat (cluster-stratified allele frequency report)

Produced by --freq when used with --within/--family. Not valid input for --read-freq.

A text file with a header line, and then C lines per variant (where C is the number of clusters) with the following 8-9 lines:

CHRChromosome code
SNPVariant identifier
CLSTCluster identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
MAFAllele 1 frequency in cluster
MACAllele 1 count in cluster
NCHROBSNumber of allele observations in cluster
.frqx (genotype count report)

Produced by --freqx. Valid input for --read-freq.

A text file with a header line, and then one line per variant with the following ten fields:

CHRChromosome code
SNPVariant identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
C(HOM A1)A1 homozygote count
C(HET)Heterozygote count
C(HOM A2)A2 homozygote count
C(HAP A1)Haploid A1 count (includes male X chromosome)
C(HAP A2)Haploid A2 count
C(MISSING)Missing genotype count
.fst (fixation index report)

Produced by --fst.

A text file with a header line, and then one line per autosomal diploid variant with the following five fields:

CHRChromosome code
SNPVariant identifier
POSBase-pair coordinate
NMISSNumber of genotype calls considered
FSTWright's FST estimate, via Weir and Cockerham's method
.gen (Oxford genotype file format)

Native text genotype file format for Oxford statistical genetics tools, such as IMPUTE2 and SNPTEST. Should always be accompanied by a .sample file. Loaded with --data/--gen, and produced by "--recode oxford".

A text file with no header line, and one line per variant with either 3N+5 or 3N+6 fields where N is the number of samples. Each line stores information for a single SNP.

In the 3N+5 case (corresponding to the original specification), the first five fields are:

  1. "SNP ID"
  2. rsID (treated by PLINK as the main variant ID)
  3. Base-pair coordinate
  4. Allele 1 (usually minor)
  5. Allele 2 (usually major)

Unless the chromosome code was declared with --oxford-single-chr (in which case the SNP ID column is ignored), PLINK has no choice but to assume that the "SNP ID" column actually stores chromosome codes. (This is the convention when PLINK exports a 5-leading-column .gen file.)

The newer 3N+6 column flavor has a dedicated chromosome column in front. This was not supported by PLINK 1.9 or 2.0 before 16 Apr 2021.

Each subsequent triplet of values then indicate likelihoods of homozygote A1, heterozygote, and homozygote A2 genotypes at this SNP, respectively, for one sample. If they add up to less than one, the remainder is a no-call probability weight.

Since the PLINK 1 binary format cannot represent genotype probabilities, calls with uncertainty greater than 0.1 are currently treated as missing, and the rest are treated as hard calls. (This behavior can be changed with --hard-call-threshold.) Note that this limitation is removed in PLINK 2.0.

.genome (identity-by-descent report)

Produced by --genome. Valid input for --read-genome.

A text file with a header line, and one line per pair of distinct samples typically with the following 14 fields:

FID1First sample's family ID
IID1First sample's within-family ID
FID2Second sample's family ID
IID2Second sample's within-family ID
RTRelationship type inferred from .fam/.ped file
EZIBD sharing expected value, based on just .fam/.ped relationship
Z0P(IBD=0)
Z1P(IBD=1)
Z2P(IBD=2)
PI_HATProportion IBD, i.e. P(IBD=2) + 0.5*P(IBD=1)
PHEPairwise phenotypic code (1, 0, -1 = case-case, case-ctrl, and ctrl-ctrl pairs, respectively)
DSTIBS distance, i.e. (IBS2 + 0.5*IBS1) / (IBS0 + IBS1 + IBS2)
PPCIBS binomial test
RATIOHETHET : IBS0 SNP ratio (expected value 2)

The pedigree relationship type codes are as follows:

  • FS: full siblings
  • HS: half siblings
  • PO: parent-offspring
  • OT: other

With the 'full' modifier, there are five additional fields at the end:

IBS0Number of IBS 0 nonmissing variants
IBS1Number of IBS 1 nonmissing variants
IBS2Number of IBS 2 nonmissing variants
HOMHOMNumber of IBS 0 SNP pairs used in PPC test
HETHETNumber of IBS 2 het/het SNP pairs used in PPC test
.grm (GCTA text relationship matrix)

Produced by --make-grm-gz. Readable by --grm-gz.

A text file with no header line, and one line per pair of samples (not necessarily distinct) with the following four fields:

  1. 1-based index of first sample in .grm.id file
  2. 1-based index of second sample in .grm.id file
  3. Number of observations (variants where neither sample has a missing call)
  4. Relationship value
.grm.N.bin, .grm.bin (GCTA 1.1+ triangular binary relationship matrix)

Produced by --make-grm-bin. Readable by --grm-bin.

These files contain single-precision (4-byte) floating point values. Using 1-based matrix indices, the first value in each file is the (1, 1) relationship value (.grm.bin) or observation count (.grm.N.bin); the second and third values are the (2, 1) and (2, 2) relationships/counts; the fourth through sixth values are the (3, 1), (3, 2) and (3, 3) relationships/counts in that order; and so on.

Note that .grm.bin files generated by GCTA versions before 1.1 have a different format.

.gvar (genetic variant format)

Produced by packages such as Birdsuite. Loaded with --gfile. Must be accompanied by .fam and .map files.

A text file with no header line, and one line per variant call with the following seven fields:

  1. Family ID
  2. Within-family ID
  3. Variant name
  4. Code for allele from first parent
  5. Copy number for first allele (can be non-integer)
  6. Code for allele from second parent
  7. Copy number for second allele
.het (method-of-moments F coefficient estimates)

Produced by --het.

A text file with a header line, and one line per sample with the following six fields:

FIDFamily ID
IIDWithin-family ID
O(HOM)Observed number of homozygotes
E(HOM)Expected number of homozygotes
N(NM)Number of (nonmissing, non-monomorphic) autosomal genotype observations
FMethod-of-moments F coefficient estimate
.hh (heterozygous haploid and nonmale Y chromosome call list)

Produced automatically when the input data contains heterozygous calls where they shouldn't be possible (haploid chromosomes, male X/Y), or there are nonmissing calls for nonmales on the Y chromosome.

A text file with one line per error (sorted primarily by variant ID, secondarily by sample ID) with the following three fields:

  1. Family ID
  2. Within-family ID
  3. Variant ID
.hom (run-of-homozygosity list)

Produced when a flag in the --homozyg family is present. Accompanied by at least a .hom.indiv and a .hom.summary file.

A text file with a header line, and one line per run with the following thirteen fields:

FIDFamily ID
IIDWithin-family ID
PHEPhenotype value
CHRChromosome code
SNP1ID of first SNP in run
SNP2ID of last SNP in run
POS1Base-pair coordinate of SNP1
POS2Base-pair coordinate of SNP2
KBLength of region in kb
NSNPNumber of SNPs in run
DENSITYInverse SNP density in kb/SNP
PHOMProportion of calls homozygous
PHETProportion of calls heterozygous

Note that PHOM + PHET can be less than 1 when missing calls are present.

.hom.indiv (sample-based runs-of-homozygosity report)

Produced when a flag in the --homozyg family is present.

A text file with a header line, and one line per sample with the following six fields:

FIDFamily ID
IIDWithin-family ID
PHEPhenotype value
NSEGNumber of runs of homozygosity
KBTotal length of runs (kb)
KBAVGAverage length of runs (kb)
.hom.overlap (run-of-homozygosity pool list)

Produced by "--homozyg group[-verbose]".

.hom.overlap files contain a header line, and P+2 lines per segment pool (where P is the number of segments in the pool) with the following 13 fields:

HeaderFirst P linesLast two lines
POOLPool ID(same)
FIDFamily ID'CON'/'UNION'
IIDWithin-family IDP
PHEPhenotype value[case ct]:[noncase ct]
CHRChromosome code(same)
SNP1ID of first SNP in segment(same)
SNP2ID of last SNP in segment(same)
BP1Base-pair coordinate of SNP1(same)
BP2Base-pair coordinate of SNP2(same)
KBLength of region in kb(same)
NSNPNumber of SNPs in run(same)
NSIMNumber of matching segments in pool'NA'
GRPAllelic-match group (see --homozyg-match)'NA'

The second-to-last line for each pool describes the consensus match segment, while the last line describes the union of all segments in the pool. Pools are separated by blank lines, and sorted primarily by pool size (largest first) and secondarily by physical position. The first pool in the file has ID 'S1', the second pool has ID 'S2', etc.

PLINK 1.07's production of this file has a minor bug and a few quirks (pairwise allelic matches are judged from (<# mismatches on joint-homozygous overlapping variants> / <# of overlapping variants>) instead of (<# mismatches on joint-homozygous overlapping variants> / <# of joint-homozygous overlapping variants>), contrary to the documentation; pools are sorted by reverse physical position; some ID numbers are skipped; samples within an allelic-match group written in an unsorted order) which are not replicated by PLINK 1.9.

.hom.overlap.S*.verbose (single ROH pool report)

"--homozyg group-verbose" also produces one .hom.overlap.<pool ID>.verbose file per pool. (Be careful with this, lest you inadvertently fill up your entire hard drive.) These files each contain G+3 sections, where G is the number of allelic-match groups. (Note that this format was not really intended to be machine-readable; if there is sufficient interest, we may clean it up in the future.)

The first section has a header line, followed by one line per sample in the pool with the following four fields:

(blank)'1)', '2)', etc.
FIDFamily ID
IIDWithin-family ID
GRPAllelic-match group (without trailing '*'s)

It ends with a single blank line.

The second section has a header line, followed by a blank line, followed by one line per variant in the segment union with the following P+1 fields:

SNPVariant identifier
'1', '2', etc.'/'-separated genotype call, [bracketed] when it's part of a ROH

There are single blank lines marking the beginning and end of the consensus match segment, and two consecutive blank lines at the end of this section.

The next G sections each start with the following S+6 header lines (where g is the 1-based allelic-match group index, S is the size of the group, and p is the 1-based index assigned to the sample in the first field of the first section):

  • 1. 'Group g'
  • 2. (blank line)
  • 3-(S+2). 4 fields: 'p)', FID, IID, phenotype value
  • S+3. (blank line)
  • S+4. (blank line)
  • S+5. S+1 fields: 'SNP', p1, ..., pS
  • S+6. (blank line)

This is followed by one line per variant with the following S+2 fields:

  • 1. Variant identifier
  • 2. Consensus haplotype, or '?' if there isn't one
  • 3-(S+2). Genotype call from section 2 (including brackets)

Single blank lines mark the beginning and end of the consensus match segment, as well as the end of the section.

The final section starts with two additional blank lines, followed by one line per variant with the following G+1 fields:

  • 1. Variant identifier
  • 2-(G+1). Consensus haplotype for allelic-match group
.hom.summary (SNP-based runs-of-homozygosity report)

Produced when a flag in the --homozyg family is present.

A text file with a header line, and one line per SNP with the following five fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
AFFNumber of cases with a run-of-homozygosity including this SNP
UNAFFNumber of non-cases with a ROH including this SNP

Note that samples with missing phenotypes are counted in the 'UNAFF' column. If the phenotype is quantitative, everyone will be counted in 'UNAFF'.

.homog (chi-square partitioning odds ratio homogeneity test report)

Produced by --homog.

A text file with a header line, followed by K+3 lines per variant with the following 13 fields (where K > 1 is the number of clusters):

CHRChromosome code
SNPVariant identifier
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
F_ACase A1 frequency
F_UControl A1 frequency
N_ACase allele count
N_UControl allele count
TESTType of test: one of {'TOTAL', 'ASSOC', 'HOMOG', cluster names}
CHISQChi-square association statistic
DFDegrees of freedom
PAsymptotic p-value
OROdds ratio
.hwe (Hardy-Weinberg equilibrium exact test statistic report)

Produced by --hardy.

A text file with a header line, and one line per marker with the following nine fields:

CHRChromosome code
SNPVariant identifier
TESTType of test: one of {'ALL', 'AFF', 'UNAFF', 'ALL(QT)', 'ALL(NP)'}
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
GENO'/'-separated genotype counts (A1 hom, het, A2 hom)
O(HET)Observed heterozygote frequency
E(HET)Expected heterozygote frequency
PHardy-Weinberg equilibrium exact test p-value
.ibc (GCTA inbreeding coefficient report)

Produced by --ibc.

A text file with a header line, and one line per sample with the following six fields:

FIDFamily ID
IIDWithin-family ID
NOMISSNumber of nonmissing genotype calls
Fhat1Variance-standardized relationship minus 1
Fhat2Excess homozygosity-based inbreeding estimate (same as PLINK --het)
Fhat3Estimate based on correlation between uniting gametes
.imiss (sample-based missing data report)

Produced by --missing, with a companion .lmiss file.

A text file with a header line, and one line per sample with the following six fields:

FIDFamily ID
IIDWithin-family ID
MISS_PHENOPhenotype missing? (Y/N)
N_MISSNumber of missing genotype call(s), not including obligatory missings or het. haploids
N_GENONumber of potentially valid call(s)
F_MISSMissing call rate
.info (Haploview map file)

Produced by "--recode HV[-1chr]", for use by Haploview. Accompanies a .ped file. With "--recode HV", one .ped + .info fileset is generated per chromosome, and the full file extensions are of the form .chr-<chromosome number>.info. This format cannot be loaded by PLINK.

A text file with no header line, and one line per variant with the following two fields:

  1. Variant identifier
  2. Base-pair coordinate
.lasso (LASSO variant effect size estimates)

Produced by --lasso. Valid input for --score.

A text file with a header line, and one line per variant with the following four fields:

CHRChromosome code (or 'COV' for covariates)
SNPVariant/covariate identifier
A1Allele 1 (usually minor; 'NA' for covariates)
EFFECTA1 effect size estimate on normalized phenotype ('NA' on monomorphic variants)
.ld (inter-variant correlation table or matrix)

Produced by --r/--r2.

If a matrix format was requested, the output is structured like a .dist file (space-delimited instead of tab-delimited if 'spaces' was specified), or its binary equivalent if the file extension ends in .bin. (See the R code snippet under the --distance documentation for an example of how to load the binary form.)

If a table report was requested instead, the file contains a header line, followed by one line per filtered variant pair with the following 7-11 fields:

CHR_AChromosome code for first variant
BP_ABase-pair coordinate of first variant
SNP_AID of first variant
MAF_AAllele 1 frequency for first variant. Requires 'with-freqs'.
CHR_BChromosome code for second variant
BP_BBase-pair coordinate of second variant
SNP_BID of second variant
PHASEIn-phase allele pairs. Requires 'in-phase'.
MAF_BAllele 1 frequency for second variant. Requires 'with-freqs'.
'R'/'R2'Correlation coefficient (squared if --r2).
'D'/'DP'Linkage disequilibrium D, or Lewontin's D-prime. Requires 'd'/'dprime'/'dprime-signed'.
.ldset (high-LD same-set variant pair report)

Produced by --set-r2 when the 'write' modifier is present.

A text file with no header line, and one section per set. A section has one line for each variant in the set, starting with the following two fields:

  1. Set name
  2. Variant ID

These are followed by a (space-delimited) list of ID(s) of other same-set variants which have pairwise r20.5 with the current variant.

Note that sets containing no significant variants are not present in this report; this is a change from PLINK 1.07's --write-set-r2's behavior. (Use "--set-p 1" if this is a problem.)

.lgen (PLINK long-format genotype file)

Produced by "--recode lgen" and "--recode lgen-ref". Accompanied by a .fam, .map, and possibly a .ref file. Loaded with --lfile.

A text file with no header line, and one line per genotype call (or just not-homozygous-major calls if 'lgen-ref' was invoked) usually with the following five fields:

  1. Family ID
  2. Within-family ID
  3. Variant identifier
  4. Allele call 1 ('0' for missing)
  5. Allele call 2

There are several variations which are also handled by PLINK; see the original discussion for details.

.list (genotype list file)

Produced by "--recode list". This format cannot be loaded by PLINK.

A text file with no header line, and four lines per variant. Each line starts with the following three fields:

  1. Chromosome code
  2. Variant identifier
  3. Genotype ('00' for missing)

This is followed by two additional fields (FID, then IID) for each sample with the specified genotype call at the variant.

.lmiss (variant-based missing data report)

Produced by --missing, with a companion .imiss file.

A text file with a header line, and K line(s) per variant with the following 5-7 fields (where K is the number of cluster(s) if --within/--family was specified, or 1 if it wasn't):

CHRChromosome code
SNPVariant identifier
CLSTCluster identifier. Only present with --within/--family.
N_MISSNumber of missing genotype call(s), not counting obligatory missings or het. haploids
N_CLSTCluster size (does not include nonmales on chrY). Only present with --within/--family.
N_GENONumber of potentially valid call(s)
F_MISSMissing call rate
.map (PLINK text fileset variant information file)

Variant information file accompanying a .ped text pedigree + genotype table. Also generated by "--recode rlist".

A text file with no header line, and one line per variant with the following 3-4 fields:

  1. Chromosome code. PLINK 1.9 also permits contig names here, but most older programs do not.
  2. Variant identifier
  3. Position in morgans or centimorgans (optional; also safe to use dummy value of '0')
  4. Base-pair coordinate

All lines must have the same number of columns (so either no lines contain the morgans/centimorgans column, or all of them do).

.mdist (genomic distance proportion matrix)

Produced by "--distance 1-ibs" and --distance-matrix.

A text file that is space-delimited if produced with --distance-matrix and tab-delimited otherwise. Shape and contents are identical to that of .dist files, except that all values are divided by twice the total variant count to convert them from Hamming distances to fractions between 0 and 1.

.mdist.missing (identity-by-missingness matrix)

Produced by "--cluster missing".

A triangular space-delimited text file with identity-by-missingness coefficients.

.mds (Haploview-friendly multidimensional scaling report)

Produced by --mds-plot.

A text file with a header line with the following D+3 fields (where D is the number of requested dimensions), and one line per sample with the same fields:

FIDFamily ID
IIDWithin-family ID
SOLCluster index (0-based)
Cx...Position on dimension x (1-based dimension indices)
.mendel, .imendel, .fmendel, .lmendel (Mendel error reports)

Produced by --mendel.

The .mendel file is a text file with a header line, and one line per error with the following six columns:

FIDFamily ID
KIDChild within-family ID
CHRChromosome code
SNPVariant identifier
CODENumeric error code
ERRORDescription of error

Note that '*/*' in the error description does not (necessarily) refer to a missing genotype call; instead, it means a Mendel error is present regardless of what that parent's genotype is.

The .lmendel file has a header line, and one line per variant with the following three columns:

CHRChromosome code
SNPVariant identifier
NNumber of Mendel errors

The .imendel file has a header line, and one subsection per nuclear family. Each subsection contains one line per family member with the following three columns:

FIDFamily ID
IIDWithin-family ID
NNumber of errors implicating this sample (only considering nuclear family)

Samples may appear more than once in this file.

Finally, the .fmendel file has a header line, and one line per nuclear family with the following five columns:

FIDFamily ID
PATPaternal within-family ID (0 if missing)
MATMaternal within-family ID (0 if missing)
CHLDNumber of offspring in nuclear family
NNumber of Mendel errors in nuclear family
.meta (meta-analysis)

Produced by --meta-analysis.

A text file with a header line, and then one line per analyzed variant with the following 8-(F+14) fields (where F is the number of input files):

CHRChromosome code. Not present with 'no-map' modifier.
BPBase-pair coordinate. Not present with 'no-map' modifier.
SNPVariant identifier
A1Allele 1. Not present with 'no-map' or 'no-allele' modifier.
A2Allele 2. Not present with 'no-map' or 'no-allele' modifier.
NNumber of valid studies for variant
PFixed-effects meta-analysis p-value
P(R)Random-effects meta-analysis p-value
'BETA'/'OR'Fixed-effects BETA/OR estimate
'BETA(R)'/'OR(R)'Random-effects BETA/OR estimate (DerSimonian and Laird)
Qp-value for Cochran's Q statistic
II2 heterogeneity index (0-100 scale)
WEIGHTED_ZWeighted Z-score, as computed by METAL. Requires 'weighted-z' modifier.
P(WZ)p-value for weighted Z-score. Requires 'weighted-z' modifier.
F[x]...Study x (0-based input file indices) effect estimate. Requires 'study' modifier.
.mibs (identity-by-state matrix)

Produced by "--distance ibs" and --ibs-matrix.

A text file that is space-delimited if produced with --distance-matrix and tab-delimited otherwise. Possible shapes are the same as for .dist and .mdist files. Each identity-by-state value is just equal to one minus the corresponding .mdist value.

.missing (case/control nonrandom missingness test report)

Produced by --test-missing.

A text file with a header line, and then one line per nondegenerate variant with the following 5 fields:

CHRChromosome code
SNPVariant identifier
F_MISS_AMissing call frequency, cases
F_MISS_UMissing call frequency, controls
PFisher's exact test p-value
.missing.hap (adjacent variant-based nonrandom missingness test report)

Produced by --test-mishap.

A text file with a header line, and then one section per autosomal diploid variant with 5+ missing calls. Each section contains one line per considered flanking haplotype, followed by a 'HETERO' line covering flanking heterozygosity (just one flanking call needs to be heterozygous), with the following 9 fields:

SNPCentral variant identifier
HAPLOTYPEHaplotype allele(s), or 'HETERO'
F_0Haplotype frequency, central call missing
F_1Haplotype frequency, central call nonmissing
M_H1#(central call missing, this hap.) / #(central call nonmissing, this hap.)
M_H2#(central call missing, other hap.) / #(central call nonmissing, other hap.)
CHISQChi-square statistic
PChi-square p-value
FLANKINGFlanking variant ID(s), '|'-delimited

Haplotype frequencies are estimated via the EM algorithm.

.model (case/control full model association report)

Produced by --model.

A text file with a header line, and then 1-5 lines per variant with the following 8-10 fields:

CHRChromosome code
SNPVariant identifier
A1A1 allele (usually minor)
A2A2 allele (usually major)
TESTType of test: one of {'GENO', 'TREND', 'ALLELIC', 'DOM', 'REC'}
AFF'/'-separated genotype or allele counts among cases
UNAFF'/'-separated genotype or allele counts among controls
CHISQChi-square statistic. Not present with 'fisher'/'fisher-midp' modifier.
DFChi-square degrees of freedom. Not present with 'fisher'/'fisher-midp'.
PP-value

Note that the Cochran-Armitage trend test is based on the full 2x3 genotype contingency table, even though only the 2x2 allele count table is displayed in the AFF/UNAFF columns on that line.

.*.mperm (max(T) permutation test report)

Produced by several association analysis commands when the 'mperm=<value>' modifier is used.

A text file with a header line, and then typically one line per variant with the following four fields:

CHRChromosome code
SNPVariant identifier
EMP1Empirical p-value (pointwise), or lower-p-value permutation count
EMP2Corrected empirical p-value (max(T) familywise) or permutation count

In the --linear/--logistic no-snp case, there is instead one line per variable with the following three fields:

TESTTest identifier
EMP1Empirical p-value, or lower-p-value permutation count
NPNumber of permutations performed
.nearest (nearest neighbor distance report)

Produced by --neighbour.

A text file with a header line, and n2-n1+1 lines per sample with the following 7-8 fields:

FIDFamily ID
IIDWithin-family ID
NNNearest neighbor level
MIN_DSTIBS distance of NNth nearest neighbor
ZZ score of MIN_DST
FID2FID of NNth nearest neighbor
IID2IID of NNth nearest neighbor
PROP_DIFFProportion of neighbors below --ppc threshold. Not present without --ppc.
.occur.dosage (dosage data variant occurrence report)

Produced by "--dosage occur".

A text file with no header line, and one line per variant with the following 2 fields:

  1. Variant ID
  2. Number of input files the variant appears in
.out.dosage (merged dosage data file)

Produced by --write-dosage.

A text file with a header line, and one line per variant with the following 3 initial fields:

SNPVariant ID
A1Allele 1 (usually minor)
A2Allele 2 (usually major)

This is followed by N 2-field blocks in the header line (with FID/IIDs), and N blocks of m dosage data fields in subsequent lines (where m is the --dosage 'format' parameter).

.ped (PLINK/MERLIN/Haploview text pedigree + genotype table)

Original standard text format for sample pedigree information and genotype calls. Normally must be accompanied by a .map file; Haploview requires an accompanying .info file instead. Loaded with --file, and produced by --recode.

Contains no header line, and one line per sample with 2V+6 fields where V is the number of variants. The first six fields are the same as those in a .fam file. The seventh and eighth fields are allele calls for the first variant in the .map file ('0' = no call); the 9th and 10th are allele calls for the second variant; and so on.

If all alleles are single-character, PLINK 1.9 will correctly parse the more compact "compound genotype" variant of this format, where each genotype call is represented as a single two-character string. This does not require the use of an additional loading flag. You can produce such a file with "--recode compound-genotypes".

It is also possible to load .ped files missing some initial fields.

.*.perm (adaptive permutation test report)

Produced by several association analysis commands when the 'perm' modifier is used.

A text file with a header line, and then one line per variant with the following 4-7 fields:

CHRChromosome code
SNPVariant identifier
BETARegression slope for real data. Only present with "--qfam emp-se".
EMP_BETASample mean of permutation regression slopes. Only present with "--qfam emp-se".
EMP_SESample stdev of permutation regression slopes. Only present with "--qfam emp-se".
EMP1Empirical p-value (pointwise), or lower-p-value permutation count
NPNumber of permutations performed for this variant
.pphe (phenotype permutations)

Produced by --make-perm-pheno. Valid input for --pheno.

A text file with no header line, and one line per sample with the following P+2 fields (where P is the requested number of permutations):

  • 1. Family ID
  • 2. Within-family ID
  • 3-(P+2). Permuted phenotypes

Missing phenotypes are always represented by the --[output-]missing-phenotype value (this is a very minor change from PLINK 1.07).

.prob (meta-analysis rejected variant list)

Produced by --meta-analysis, when at least one variant is rejected.

A text file with no header line, and then one line per problem with the following 3 fields:

  1. Filename
  2. Variant ID
  3. Problem code (one of {'BAD_{CHR,BP,ES,SE,P,ESS}', 'MISSING_{A1,A2}', 'ALLELE_MISMATCH', 'DUPLICATE'})

Multiple problems may be reported for a single (filename, variant ID) pair.

.profile (allelic scoring results)

Produced by --score.

A text file with a header line, and then one line per sample with the following 4-6 fields:

FIDFamily ID
IIDWithin-family ID
PHENOPhenotype value
CNT# of nonmissing alleles used for scoring. May require 'include-cnt'.
CNT2Sum of named allele counts. Not present with --dosage.
'SCORE'/'SCORESUM'Score (normally an allele-based average, unless 'sum' modifier used)
.qassoc (quantitative trait association test report)

Produced by --assoc acting on a quantitative phenotype.

A text file with a header line, and then one line per variant with the following 9-11 fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
NMISSNumber of nonmissing genotype calls
BETARegression coefficient
SEStandard error
R2Regression r-squared
TWald test (based on t-distribution)
PWald test asymptotic p-value
LINLin statistic. Only present with 'lin' modifier.
LIN_PLin test p-value. Only present with 'lin'.
.qassoc.gxe (quantitative trait interaction test report)

Produced by --gxe.

A text file with a header line, and then one line per variant with the following 10 fields:

CHRChromosome code
SNPVariant identifier
NMISS1Nonmissing genotype calls in first group
BETA1Regression coefficient for first group
SE1Regression coefficient standard error for first group
NMISS2Nonmissing genotype calls in second group
BETA2Regression coefficient for second group
SE2Regression coefficient standard error for second group
Z_GXEZ score, test for interaction
P_GXEAsymptotic p-value
.qassoc.means (quantitative trait association genotype-stratified mean report)

Produced by "--assoc qt-means".

A text file with a header line, and then five lines per variant with the following six fields:

CHRChromosome code
SNPVariant identifier
VALUEType of value: one of {'GENO', 'COUNTS', 'FREQ', 'MEAN', 'SD'}
G11Value for homozygous A1 genotype
G12Value for heterozygous genotype
G22Value for homozygous A2 genotype
.qfam.* (family-based quantitative trait association report)

Produced by the --qfam family of commands.

A .qfam.{within,parents,between,total} file has a header line, and one line per variant with the following nine fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
A1Allele 1 (usually minor)
TESTTest type ('TOT', 'BET', or 'WITH')
NINDNumber of samples in linear regression
BETARegression coefficient
STATT-statistic (just for permutation test; don't use it directly)
RAW_PUncorrected p-value

A .qfam.{within,parents,between,total}.perm file is also generated.

.range.report (reprocessed gene-based report)

Produced by --gene-report.

The .range.report file has one subsection per nonempty gene. Each subsection contains a header line of the form "<gene name> -- <start/end coordinate pairs, comma-separated if necessary> ( <kb length> ) [border description, if necessary]"; this is followed by a blank line, the original report's header line with 'DIST' inserted in front, and the lines in the original report which concerned SNPs in the gene (preceded by <current pos> - <gene start coordinate> DIST values). Subsections are separated by two blank lines.

There are four small changes from PLINK 1.07:

  • Genes now appear in natural-sorted instead of ASCII-sorted order (e.g. ABCA1 < ABCA3 < ABCA10, instead of the old ABCA1 < ABCA10 < ABCA3).
  • kb lengths are larger by 0.001, since intervals in gene region files are fully closed instead of half-open.
  • If --gene-list-border was specified, intervals and lengths in header lines do not include the additional padding.
  • When a gene contains several disjoint regions on the same chromosome, they are now reported in a single subsection.
.raw (additive + dominant component file)

Produced by "--recode A" and "--recode AD", for use with R. This format cannot be loaded by PLINK.

A text file with a header line, and then one line per sample with V+6 (for "--recode A") or 2V+6 (for "--recode AD") fields, where V is the number of variants. The first six fields are:

FIDFamily ID
IIDWithin-family ID
PATPaternal within-family ID
MATMaternal within-family ID
SEXSex (1 = male, 2 = female, 0 = unknown)
PHENOTYPEMain phenotype value

This is followed by one or two fields per variant:

<Variant ID>_<counted allele>Allelic dosage (0/1/2/'NA' for diploid variants, 0/2/'NA' for haploid)
<Variant ID>_HETDominant component (1 = het, 0 otherwise). Requires "--recode AD".

If 'include-alt' was specified, the header line also names alternate allele codes in parentheses, e.g. 'rs5939319_G(/A)'.

.recode.{geno,pheno,pos}.txt (BIMBAM genotype, phenotype, and variant position file)

Produced by "--recode bimbam", for use by BIMBAM. This format cannot be loaded by PLINK.

The .recode.geno.txt file produced by PLINK is a comma-delimited text file. It starts with two short header lines: N on its own line (where N is the number of samples), followed by number of variants on its own line. The third header line starts with 'IND', and is followed by the IIDs of all samples.

The main body of the file has one line per variant with N+1 fields: the variant ID, followed by compound genotypes (with missing genotypes denoted by '??').

The .recode.pheno.txt file produced by PLINK is just a sequence of sample phenotype values, one per line.

The .recode.pos.txt file produced by PLINK is a text file with no header line, and one line per variant with the following 2-3 (space-delimited) fields:

  1. Variant identifier
  2. Base-pair coordinate
  3. Chromosome code (not present with 'bimbam-1chr')
.recode.phase.inp (fastPHASE format)

Produced by "--recode fastphase[-1chr]", for use by fastPHASE. With "--recode fastphase", one file is generated per chromosome, and the full file extensions are of the form .chr-<chromosome number>.recode.phase.inp. This format cannot be loaded by PLINK.

Each .phase.inp file produced by PLINK starts with two short header lines: number of samples on its own line, followed by V on its own line (where V is the number of variants). The third header line starts with 'P', and is followed by the base-pair coordinates of all variants.

The main body of the file has three lines per sample. The first line in each triplet is:

  1. '#'
  2. 'ID'
  3. Within-family ID

The second and third lines each have a single M-character string, with one character per allele call. Missing calls are coded as '?'.

.recode.strct_in (Structure format)

Produced by "--recode structure", for use by Structure. This format cannot be loaded by PLINK.

A text file with two header lines: the first header line lists all V variant IDs, while each entry in the second line is the difference between the current variant's base-pair coordinate and the previous variant's bp coordinate (or -1 when the current variant starts a new chromosome). This is followed by one line per sample with the following 2V+2 fields:

  • 1. Within-family ID
  • 2. Positive integer, unique for each FID
  • 3-(2V+2). Genotype calls, with the A1 allele coded as '1', A2 = '2', and missing = '0'
.ref (long-format reference allele file)

Reference allele file which accompanies a .lgen file when it's generated with "--recode lgen-ref". Loaded with --lfile + --reference.

A text file with no header line, and one line per polymorphic variant with the following 2-3 fields:

  1. Variant identifier
  2. Major allele
  3. Minor allele (not present if there is no minor allele)
.rel (text relationship matrix)

Produced by --make-rel.

Contents are identical to that of a .grm/.grm.bin file. Possible shapes are essentially the same as for .dist files; the only difference is that .dist files have an omitted or zero diagonal while .rel files do not.

.rlist (rare genotype list file)

Produced by "--recode rlist". Accompanied by .fam and .map files. This format cannot be loaded by PLINK.

A text file with no header line, and 0-3 lines per variant. Each line starts with the following four fields:

  1. Variant identifier
  2. Genotype class ('HOM' = homozygous minor, 'HET' = heterozygous, 'NIL' = missing call)
  3. Allele 1 ('0' for missing)
  4. Allele 2

This is followed by two additional fields (FID, then IID) for each sample with the specified genotype call at the variant. If there are no such samples, the entire line is omitted from the file. (As a result, any variants with nothing but homozygous major genotypes are not mentioned at all.)

.sample (Oxford sample information file)

Sample information file accompanying a .gen genotype dosage file. Loaded with --data/--sample, and produced by "--recode oxford".

The .sample space-delimited files emitted by --recode have two header lines, and then one line per sample with 3-5 relevant fields:

First header lineSecond header lineSubsequent contents
ID_10Family ID
ID_20Within-family ID
missing0Missing call frequency
sexDSex code ('1' = male, '2' = female, '0' = unknown)
phenotype'B'/'P'Binary ('0' = control, '1' = case) or continuous phenotype

A specification for this format is on the QCTOOL v2 website.

.set ('END'-terminated variant set membership list file)

Produced by --write-set, and loaded with --set.

A text file with a sequence of variant set definitions. Each set definition starts with the set ID, followed by IDs of all variants in the set, followed by 'END'. Spaces, tabs, and newlines are acceptable and equivalent token delimiters; the files emitted by --write-set have a single token per line and a blank line between sets, but you can e.g. describe an entire set per line instead, and --set will still read the file correctly.

For example, the .set file

GENE1
rs123456
rs10912
rs66222
END

GENE2 rs66222 rs929292
rs288222 END

assigns variants rs123456 and rs10912 to set 'GENE1', rs929292 and rs288222 to 'GENE2', and rs66222 to both sets.

When multiple set definitions share the same set ID, that currently results in an error rather than a merge.

.set.{perm|mperm} (set association permutation test report)

Produced by --assoc/--model/--linear/--logistic/--tdt/--mh/--bd when run with the 'set-test' modifier.

A text file with a header line, and then one line per set with the following 6-7 fields:

SETSet ID
NSNPSet size
NSIGRaw number of significant variants
ISIGFinal size of most-significant-variants subset (after --set-r2 and --set-max thresholds)
EMP1Empirical set p-value, or lower-p-value permutation count
NPNumber of permutations performed. Requires 'perm-count'.
SNPS'|'-delimited IDs for most-significant-variants subset ('NA' if empty)

Calculation of NSIG is no longer cut short when the --set-max value is hit.

.set.table (variant set membership table)

Produced by --set-table.

A tab-delimited text file with a header line, and then one line per variant with the following 3+S columns (where S is the number of sets):

SNPVariant identifier
CHRChromosome code
BPBase-pair coordinate
Set IDs...1 = member, 0 = nonmember

Variants which aren't a member of any set still appear in the table.

PLINK 1.07 wrote double-tabs on most lines between the 3rd and 4th columns; this no longer occurs.

.sexcheck (X chromosome-based sex validity report)

Produced by --check-sex/--impute-sex.

A text file with a header line, and then one line per sample with the following 6-7 fields:

FIDFamily ID
IIDWithin-family ID
PEDSEXSex code in input file
SNPSEXImputed sex code (1 = male, 2 = female, 0 = unknown)
STATUS'OK' if PEDSEX and SNPSEX match and are nonzero, 'PROBLEM' otherwise
FInbreeding coefficient, considering only X chromosome. Not present with 'y-only'.
YCOUNTNumber of nonmissing genotype calls on Y chromosome. Requires 'ycount'/'y-only'.
.simfreq (simulation parameter file)

Produced by --simulate{-qt}, and can be reread by them.

If generated by --simulate without the 'tags' or 'haps' modifier, it is a text file with no header line, and one line per SNP set with the following 6 fields:

  1. Number of SNPs in set (always 1 in autogenerated file)
  2. Label of this set of SNPs
  3. Reference allele frequency lower bound
  4. Reference allele frequency upper bound (equal to lower bound in autogenerated file)
  5. odds(case | heterozygote) / odds(case | homozygous for alternate allele)
  6. odds(case | homozygous for ref. allele) / odds(case | homozygous for alt. allele)

With 'tags' or 'haps', each line has the following 9 fields instead:

  1. Number of SNPs in set (always 1 in autogenerated file)
  2. Label of this set of SNPs
  3. Reference allele frequency lower bound, causal variant
  4. Reference allele frequency upper bound, causal variant
  5. Reference allele frequency lower bound, marker
  6. Reference allele frequency upper bound, marker
  7. Marker-causal variant LD
  8. odds(case | heterozygote) / odds(case | homozygous for alternate allele)
  9. odds(case | homozygous for ref. allele) / odds(case | homozygous for alt. allele)

With --simulate-qt, in both subcases the last two fields are replaced with:

  • Additive genetic variance for each SNP
  • Dominance deviation
.tags.list (tagging variant report)

Produced by --show-tags, when used in 'all' mode or with the --list-all flag.

A text file with a header line, and then one line per target variant with the following eight fields:

SNPVariant identifier
CHRChromosome code
BPBase-pair coordinate
NTAGNumber of other variants tagging this
LEFTBase-pair coordinate of earliest tag variant, including this
RIGHTBase-pair coordinate of latest tag variant, including this
KBSPAN(RIGHT - LEFT + 1) / 1000
TAGS'|'-delimited list of IDs of other variants tagging this (or 'NONE')
.tdt (transmission disequilibrium test report)

Produced by --tdt (unless parent-of-origin analysis was requested).

A text file with a header line, and then one line per autosomal/chrX variant typically with the following 14-15 fields:

CHRChromosome code
SNPVariant identifier
BPBase-pair coordinate
A1Allele 1 (usually minor)
A2Allele 2 (usually major)
TTransmitted A1 allele count
UUntransmitted A1 allele count
ORTDT odds ratio
CHISQTDT chi-square statistic. Not present with 'exact'/'exact-midp'.
PChi-square (default) or binomial test (if 'exact'/'exact-midp' specified) p-value
A:U_PARParental affected A2 excess:unaffected A2 excess
CHISQ_PARParental discordance chi-square statistic
P_PARParental discordance chi-square p-value
CHISQ_COMCombined test chi-square statistic
P_COMCombined test chi-square p-value

The last five fields do not appear if no considered trio has parents with discordant phenotypes.

If --ci 0.xy has also been specified, the following two fields are inserted after 'OR':

LxyBottom of xy% symmetric approx. confidence interval for TDT odds ratio
UxyTop of xy% approx. confidence interval for TDT odds ratio
.tdt.poo (parent-of-origin analysis)

Produced by "--tdt poo".

A text file with a header line, and then one line per autosomal/chrX variant with the following 11 fields:

CHRChromosome code
SNPVariant identifier
A1:A2Allele 1 code:allele 2 code
T:U_PATPaternal A1:A2 transmission counts
CHISQ_PATPaternal chi-square statistic
P_PATPaternal chi-square p-value
T:U_MATMaternal A1:A2 transmission counts
CHISQ_MATMaternal chi-square statistic
P_PATMaternal chi-square p-value
Z_POOZ score for paternal/maternal odds ratio difference
P_POOAsymptotic parent-of-origin test p-value
.tfam (PLINK sample information file)

Sample information file accompanying a .tped file; identical format to .fam files.

.tped (PLINK transposed text genotype table)

Variant information + genotype call text file. Must be accompanied by a .tfam file. Loaded with --tfile, and produced by "--recode transpose".

Contains no header line, and one line per variant with 2N+4 fields where N is the number of samples. The first four fields are the same as those in a .map file. The fifth and sixth fields are allele calls for the first sample in the .tfam file ('0' = no call); the 7th and 8th are allele calls for the second sample; and so on.

.traw (variant-major additive component file)

Produced by "--recode A-transpose", for use with R. This format can only be loaded by PLINK 2.0.

A text file with a header line, and then one line per variant with the following N+6 fields (where N is the number of samples):

CHRChromosome code
SNPVariant identifier
(C)MPosition in morgans or centimorgans
POSBase-pair coordinate
COUNTEDCounted allele (defaults to A1)
ALTOther allele(s), comma-separated
<FID>_<IID>...Allelic dosages (0/1/2/'NA' for diploid variants, 0/2/'NA' for haploid)

Since this format is new to PLINK 1.9, it is tab-delimited by default; use the 'spacex' modifier to force spaces.

.twolocus (4x4 joint genotype count table, single variant pair)

Produced by --twolocus.

A text file with 1-3 sections, depending on whether cases and/or controls are present. The first section starts with two header lines:

  1. "All individuals"
  2. (underline)

This is followed by two tables. Each table has two header lines of its own:

  1. Second variant ID
  2. Five column headers: <A1 allele code>/<A1 allele code>, <A1>/<A2>, <A2>/<A2>, '0/0', '*/*'

then rows corresponding to A1/A1, A1/A2, A2/A2, and missing first variant genotypes, then a fifth row with (sub)totals. The first table contains raw counts, while the second table contains proportions of the grand total.

This is followed by a 'Cases' section if there is at least one case, and finally a 'Controls' section if there is at least one control.

.var.ranges (equal-size variant ranges)

Produced by --write-var-ranges.

A text file with a header line, and then one line per range with the following two fields:

FIRSTFirst variant ID
LASTLast variant ID
.vcf (1000 Genomes Project text Variant Call Format)

Variant information + sample ID + genotype call text file. Loaded with --vcf, and produced by "--recode vcf" (or vcf-fid/vcf-iid). Do not use PLINK for general-purpose VCF handling: all information in VCF files which cannot be represented by the PLINK 1 binary format is ignored.

The VCFv4.2 files emitted by --recode normally start with 5+C header lines, where C is the number of chromosomes:

  • 1. ##fileformat=VCFv4.2
  • 2. ##fileDate=<yyyymmdd date>
  • 3. ##source=PLINKv1.90
  • 4-(C+3). ##contig=<ID=<chromosome code>,length=<last bp coordinate value + 1, or 231 - 3 if unknown>>
  • C+4. ##INFO=<ID=PR,Number=0,Type=Flag,Description="Provisional reference allele, may not be based on real reference genome">
  • C+5. ##FORMAT=<ID=GT,Number=1,Type=String,Description="Genotype">

(The INFO line is omitted when --real-ref-alleles is specified.)

This is followed by a tab-delimited header line with the following N+9 fields (where N is the number of samples), and one tab-delimited line per variant with the same fields:

#CHROMChromosome code/name
POSBase-pair coordinate
IDVariant identifier
REFAllele 2 code (missing = 'N')
ALTAllele 1 code (missing = '.')
QUALLeft blank ('.')
FILTERLeft blank ('.')
INFONormally 'PR'; '.' when --real-ref-alleles specified
FORMAT'GT' (signaling the presence of genotype calls)
Sample IDs...Genotype calls ('/'-separated if diploid, 0=ref, 1=alt, '.'=missing)

Allele codes are supposed to either start with '<', only contain characters in the set {A,C,G,T,N,a,c,g,t,n}, or represent a breakend. --recode issues a warning if an allele code does not satisfy this restriction.

The full VCFv4.2 specification is in the hts-specs GitHub repository.

Complete flag index >>