Movatterモバイル変換


[0]ホーム

URL:


Title:Construction of Genetic Maps in Experimental Crosses
Version:3.2.2
Description:Analysis of molecular marker data from model and non-model systems. For the later, it allows statistical analysis by simultaneously estimating linkage and linkage phases (genetic map construction) according to Wu and colleagues (2002) <doi:10.1006/tpbi.2002.1577>. All analysis are based on multi-point approaches using hidden Markov models.
Author:Gabriel Margarido [aut], Marcelo Mollinari [aut], Cristiane Taniguti [ctb, cre], Getulio Ferreira [ctb], Rodrigo Amadeu [ctb], Jeekin Lau [ctb], Karl Broman [ctb], Katharine Preedy [ctb, cph] (MDS ordering algorithm), Bastian Schiffthaler [ctb, cph] (HMM parallelization), Augusto Garcia [aut, ctb]
LinkingTo:Rcpp (≥ 1.0.0)
Depends:R (≥ 3.6.0)
Imports:ggplot2 (≥ 2.2.1), plotly (≥ 4.7.1), reshape2 (≥ 1.4.1),Rcpp (≥ 0.10.5), graphics, methods, stats, utils, grDevices,smacof, princurve, parallel, dplyr, tidyr, htmlwidgets, ggpubr,RColorBrewer, dendextend, rebus, vcfR (≥ 1.6.0)
Suggests:knitr (≥ 1.10), rmarkdown, testthat, stringr
VignetteBuilder:knitr
Encoding:UTF-8
License:GPL-3
URL:https://github.com/cristianetaniguti/onemap
BugReports:https://github.com/Cristianetaniguti/onemap/issues
Maintainer:Cristiane Taniguti <cht47@cornell.edu>
Repository:CRAN
Packaged:2025-05-16 14:04:33 UTC; cht47
NeedsCompilation:yes
Date/Publication:2025-05-16 14:30:02 UTC
RoxygenNote:7.3.2

Calculates individual significance level to be used to achieve a global alpha (with Bonferroni)

Description

It shows the alpha value to be used in each chi-square segregation test, in order to achievea given global type I error. To do so, it uses Bonferroni's criteria.

Usage

Bonferroni_alpha(x, global.alpha = 0.05)

Arguments

x

an object of class onemap_segreg_test

global.alpha

the global alpha that

Value

the alpha value for each test (numeric)

Examples

 data(onemap_example_bc) # Loads a fake backcross dataset installed with onemap Chi <- test_segregation(onemap_example_bc) # Performs the chi-square test for all markers print(Chi) # Shows the results of the Chi-square tests Bonferroni_alpha (Chi) # Shows the individual alpha level to be used

Perform gaussian sum

Description

Perform gaussian sum

Usage

acum(w)

Arguments

w

vector of numbers


Creates a new sequence by adding markers.

Description

Creates a new sequence by adding markers from a predeterminedone. The markers are added in the end of the sequence.

Usage

add_marker(input.seq, mrks)

Arguments

input.seq

an object of classsequence.

mrks

a vector containing the markers to be added from thesequence.

Value

An object of classsequence, which is a listcontaining the following components:

seq.num

avector containing the (ordered) indices ofmarkers in the sequence, according to the input file.

seq.phases

avector with the linkage phases betweenmarkers in the sequence, in corresponding positions.-1means that there are no defined linkage phases.

seq.rf

avector with the recombination fractionsbetween markers in the sequence.-1 means that thereare no estimated recombination fractions.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemapwith the raw data.

twopt

name of the object of classrf_2pts with the2-point analyses.

@author Marcelo Mollinari,mmollina@usp.br

See Also

drop_marker

Examples

data(onemap_example_out)twopt <- rf_2pts(onemap_example_out)all_mark <- make_seq(twopt,"all")groups <- group(all_mark)(LG1 <- make_seq(groups,1))(LG.aug<-add_marker(LG1, c(4,7)))

Add the redundant markers removed by create_data_bins function

Description

Add the redundant markers removed by create_data_bins function

Usage

add_redundants(sequence, onemap.obj, bins)

Arguments

sequence

object of classsequence

onemap.obj

object of classonemap.obj before redundant markers were removed

bins

object of classonemap_bin

Value

New sequence object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

object of classonemap with the rawdata.

twopt

object of classrf_2pts with the2-point analyses.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

See Also

find_bins


Onemap object sanity check

Description

Based on MAPpoly check_data_sanity function by Marcelo Mollinari

Usage

check_data(x)

Arguments

x

an object of classonemap

Value

if consistent, returns 0. If not consistent, returns a vector with a number of tests, whereTRUE indicatesa failed test.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

data(onemap_example_bc)check_data(onemap_example_bc)

Twopts object sanity check

Description

Based on MAPpoly check_data_sanity function by Marcelo Mollinari

Usage

check_twopts(x)

Arguments

x

an object of classonemap

Value

if consistent, returns 0. If not consistent, returns a vector with a number of tests, whereTRUE indicatesa failed test.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

data(onemap_example_bc)twopts <- rf_2pts(onemap_example_bc)check_twopts(twopts)

Combine OneMap datasets

Description

Merge two or more OneMap datasets from the same cross type. Creates anobject of classonemap.

Usage

combine_onemap(...)

Arguments

...

Two or moreonemap dataset objects of the same crosstype.

Details

Given a set of OneMap datasets, all from the same cross type (full-sib,backcross, F2 intercross or recombinant inbred lines obtained by self-or sib-mating), merges marker and phenotype information to create asingleonemap object.

If sample IDs are present in all datasets (the standard new format), notall individuals need to be genotyped in all datasets - the merged datasetwill contain all available information, with missing data elsewhere. Ifsample IDs are missing in at least one dataset, it is required that alldatasets have the same number of individuals, and it is assumed that theyare arranged in the same order in every dataset.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

a string indicating that this is acombined dataset.

n.phe

number of phenotypes.

pheno

amatrix with phenotypic values. Each column contains data for a trait andeach row represents an individual.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com

References

Lincoln, S. E., Daly, M. J. and Lander, E. S. (1993)Constructing genetic linkage maps with MAPMAKER/EXP Version 3.0: a tutorialand reference manual.A Whitehead Institute for Biomedical ResearchTechnical Report.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

See Also

read_onemap andread_mapmaker.

Examples

        data("onemap_example_out")    data("vcf_example_out")    combined_data <- combine_onemap(onemap_example_out, vcf_example_out)

Compare all possible orders (exhaustive search) for a given sequence ofmarkers

Description

For a given sequence withn markers, computes the multipointlikelihood of all\frac{n!}{2} possible orders.

Usage

compare(input.seq, n.best = 50, tol = 0.001, verbose = FALSE)

Arguments

input.seq

an object of classsequence.

n.best

the number of best orders to store in object (defaults to50).

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

verbose

ifFALSE (default), simplified output is displayed.ifTRUE, detailed output is displayed.

Details

Since the number\frac{n!}{2} is large even for moderate valuesofn, this function is to be used only for sequences withrelatively few markers. If markers were genotyped in an outcross population,linkage phases need to be estimated and therefore more states need to bevisited in the Markov chain; when segregation types are D1, D2 and C,computation can required a very long time (specially when markers linked inrepulsion are involved), so we recommend to use this function up to 6 or 7 markers.For inbred-based populations, up to 10 or 11 markers can be ordered with this function,since linkage phase are known.The multipoint likelihood is calculated according to Wu et al.(2002b) (Eqs. 7a to 11), assuming that the recombination fraction is thesame in both parents. Hidden Markov chain codes adapted from Broman et al.(2008) were used.

Value

An object of classcompare, which is a list containing thefollowing components:

best.ord

amatrix containing the bestorders.

best.ord.rf

amatrix with recombination frequenciesfor the corresponding best orders.

best.ord.phase

amatrixwith linkage phases for the best orders.

best.ord.like

avector with log-likelihood values for the best orders.

best.ord.LOD

avector with LOD Score values for the bestorders.

data.name

name of the object of classonemap withthe raw data.

twopt

name of the object of classrf_2pts withthe 2-point analyses.

Author(s)

Marcelo Mollinari,mmollina@usp.br

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Jiang, C. and Zeng, Z.-B. (1997). Mapping quantitative trait loci withdominant and missing markers in various crosses from two inbred lines.Genetica 101: 47-58.

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M. J., Lincoln,S. E. and Newburg, L. (1987) MAPMAKER: An interactive computer package forconstructing primary genetic linkage maps of experimental and naturalpopulations.Genomics 1: 174-181.

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia, A. A. F.(2009) Evaluation of algorithms used to order markers on genetics maps._Heredity_ 103: 494-502.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkage mapping ofsex-specific differences.Genetical Research 79: 85-96

See Also

marker_type for details about segregationtypes andmake_seq.

Examples

  #outcrossing example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  markers <- make_seq(twopt,c(12,14,15,26,28))  (markers.comp <- compare(markers))  (markers.comp <- compare(markers,verbose=TRUE))  #F2 example  data(onemap_example_f2)  twopt <- rf_2pts(onemap_example_f2)  markers <- make_seq(twopt,c(17,26,29,30,44,46,55))  (markers.comp <- compare(markers))  (markers.comp <- compare(markers,verbose=TRUE))

New dataset based on bins

Description

Creates a new dataset based ononemap_bin object

Usage

create_data_bins(input.obj, bins)

Arguments

input.obj

an object of classonemap.

bins

an object of classonemap_bin.

Details

Given aonemap_bin object,creates a new data set where the redundant markers arecollapsed into bins and represented by the marker with the loweramount of missing data among those on the bin.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

error

matrix containing HMM emission probabilities

Author(s)

Marcelo Mollinari,mmollina@usp.br

See Also

find_bins

Examples

  data("onemap_example_f2")  (bins<-find_bins(onemap_example_f2, exact=FALSE))  onemap_bins <- create_data_bins(onemap_example_f2, bins)

Create a dataframe suitable for a ggplot2 graphic

Description

An internal function that prepares a dataframe suitable fordrawing a graphic of raw data using ggplot2, i. e., a data framewith long format

Usage

create_dataframe_for_plot_outcross(x)

Arguments

x

an object of classesonemap andoutcross, with data and additional information

Value

a dataframe


Create database and ggplot graphic of allele reads depths

Description

Create database and ggplot graphic of allele reads depths

Usage

create_depths_profile(  onemap.obj = NULL,  vcfR.object = NULL,  vcf = NULL,  parent1 = NULL,  parent2 = NULL,  vcf.par = "AD",  recovering = FALSE,  mks = NULL,  inds = NULL,  GTfrom = "onemap",  alpha = 1,  rds.file = "data.rds",  y_lim = NULL,  x_lim = NULL,  verbose = TRUE)

Arguments

onemap.obj

an object of classonemap.

vcfR.object

object of class vcfR;

vcf

path to VCF file.

parent1

a character specifying the first parent ID

parent2

a character specifying the second parent ID

vcf.par

the vcf parameter that store the allele depth information.

recovering

logical. If TRUE, all markers in vcf are consider, if FALSE only those in onemap.obj

mks

a vector of characters specifying the markers names to be considered or NULL to consider all markers

inds

a vector of characters specifying the individual names to be considered or NULL to consider all individuals

GTfrom

the graphic should contain the genotypes from onemap.obj or from the vcf? Specify using "onemap", "vcf" or "prob".

alpha

define the transparency of the dots in the graphic

rds.file

rds file name to store the data frame with values used to build the graphic

y_lim

set scale limit for y axis

x_lim

set scale limit for x axis

verbose

IfTRUE, print tracing information.

Value

an rds file and a ggplot graphic.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

See Also

onemap_read_vcfR


Build genotype probabilities matrix for hmm

Description

The genotypes probabilities can be calculated considering a global error (default method)or considering a genotype error probability for each genotype. Furthermore, user can provide directly the genotype probability matrix.

Usage

create_probs(  input.obj = NULL,  global_error = NULL,  genotypes_errors = NULL,  genotypes_probs = NULL)

Arguments

input.obj

object of class onemap or onemap sequence

global_error

a integer specifying the global error value

genotypes_errors

a matrix with dimensions (number of individuals) x (number of markers) with genotypes errors values

genotypes_probs

a matrix with dimensions (number of individuals)*(number of markers) x possible genotypes (i.e., a ab ba b) with four columns for f2 and outcrossing populations, and two for backcross and RILs).

Details

The genotype probability matrix has number of individuals x number of markers rows andfour columns (or two if considering backcross or RILs populations), one for each possible genotypeof the population. This format follows the one proposed by MAPpoly.

The genotype probabilities come from SNP calling methods. If you do not have them, you can use a globalerror or a error value for each genotype. The OneMap until 2.1 version have only the global error option.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

error

matrix containing HMM emission probabilities

Author(s)

Cristiane Tanigutichtaniguti@tamu.edu

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

See Also

make_seq

Examples

  data(onemap_example_out)  new.data <- create_probs(onemap_example_out, global_error = 10^-5)

Draw a genetic map

Description

Provides a simple draw of a genetic map.

Usage

draw_map(  map.list,  horizontal = FALSE,  names = FALSE,  grid = FALSE,  cex.mrk = 1,  cex.grp = 0.75)

Arguments

map.list

a map, i.e. an object of classsequence with apredefined order, linkage phases, recombination fraction and likelihood;also it could be a list of maps.

horizontal

ifTRUE, indicates that the map should be plottedhorizontally. Default isFALSE

names

ifTRUE, displays the names of the markers. Default isFALSE

grid

ifTRUE, displays a grid in the background. Default isFALSE

cex.mrk

the magnification to be used for markers.

cex.grp

the magnification to be used for group axis annotation.

Value

figure with genetic map draw

Author(s)

Marcelo Mollinari,mmollina@usp.br

Examples

 #outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  lg<-group(make_seq(twopt, "all"))  maps<-vector("list", lg$n.groups)  for(i in 1:lg$n.groups)     maps[[i]]<- make_seq(order_seq(input.seq= make_seq(lg,i),twopt.alg =   "rcd"), "force")  draw_map(maps, grid=TRUE)  draw_map(maps, grid=TRUE, horizontal=TRUE)

Draw a linkage map

Description

Provides a simple draw of a linkage map.

Usage

draw_map2(  ...,  tag = NULL,  id = TRUE,  pos = TRUE,  cex.label = NULL,  main = NULL,  group.names = NULL,  centered = FALSE,  y.axis = TRUE,  space = NULL,  col.group = NULL,  col.mark = NULL,  col.tag = NULL,  output = NULL,  verbose = TRUE)

Arguments

...

map(s). Object(s) of classsequence and/ordata.frame. Ifdata.frame, it must have two columns: column 1: marker id; column 2: position (cM) (numeric).

tag

name(s) of the marker(s) to highlight. If "all", all markers will be highlighted. Default isNULL.

id

logical. IfTRUE (default), shows name(s) of tagged marker(s).

pos

logical. IfTRUE (default), shows position(s) of tagged marker(s).

cex.label

the magnification used for label(s) of tagged marker(s). IfNULL (default), the cex will be automatically calculated to avoid overlapping.

main

an overall title for the plot. Default isNULL.

group.names

name(s) to identify the group(s). IfNULL (default), the name(s) of the sequence(s) will be used.

centered

logical. IfTRUE, the group(s) will be aligned in the center. IfFALSE (default), the group(s) will be aligned at the top.

y.axis

logical. IfTRUE (default), shows y axis. If centered =TRUE, the y axis will always be hidden.

space

numerical. Spacing between groups. IfNULL (default), the spacing will be automatically calculated to avoid overlapping.

col.group

the color used for group(s).

col.mark

the color used for marker(s).

col.tag

the color used for highlighted marker(s) and its/theirs label(s).

output

the name of the output file. The file format can be specified by adding its extension. Available formats: 'bmp', 'jpeg', 'png', 'tiff', 'pdf' and 'eps' (default).

verbose

IfTRUE, print tracing information.

Value

ggplot graphic with genetic map draw

Author(s)

Getulio Caixeta Ferreira,getulio.caifer@gmail.com

Examples

data("onemap_example_out")twopt <- rf_2pts(onemap_example_out)lg<-group(make_seq(twopt, "all"))seq1<-make_seq(order_seq(input.seq= make_seq(lg,1),twopt.alg = "rcd"), "force")seq2<-make_seq(order_seq(input.seq= make_seq(lg,2),twopt.alg = "rcd"), "force")seq3<-make_seq(order_seq(input.seq= make_seq(lg,3),twopt.alg = "rcd"), "force")draw_map2(seq1,seq2,seq3,tag = c("M1","M2","M3","M4","M5"),output = paste0(tempfile(), ".png"))

Creates a new sequence by dropping markers.

Description

Creates a new sequence by dropping markers from a predeterminedone.

Usage

drop_marker(input.seq, mrks)

Arguments

input.seq

an object of classsequence.

mrks

a vector containing the markers to be removedfrom thesequence.

Value

An object of classsequence, which is a listcontaining the following components:

seq.num

avector containing the (ordered) indices ofmarkers in the sequence, according to the input file.

seq.phases

avector with the linkage phases betweenmarkers in the sequence, in corresponding positions.-1means that there are no defined linkage phases.

seq.rf

avector with the recombination fractionsbetween markers in the sequence.-1 means that thereare no estimated recombination fractions.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemapwith the raw data.

twopt

name of the object of classrf_2pts with the2-point analyses.

@author Marcelo Mollinari,mmollina@usp.br

See Also

add_marker

Examples

data(onemap_example_out)twopt <- rf_2pts(onemap_example_out)all_mark <- make_seq(twopt,"all")groups <- group(all_mark)(LG1 <- make_seq(groups,1))(LG.aug<-drop_marker(LG1, c(10,14)))

Edit sequence ordered by reference genome positions comparing to another set order

Description

Edit sequence ordered by reference genome positions comparing to another set order

Usage

edit_order_onemap(input.seq)

Arguments

input.seq

object of class sequence with alternative order (not genomic order)

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Produce empty object to avoid code break. Function for internal purpose.

Description

Produce empty object to avoid code break. Function for internal purpose.

Usage

empty_onemap_obj(vcf, P1, P2, cross)

Arguments

vcf

object of class vcfR

P1

character with parent 1 ID

P2

character with parent 2 ID

cross

type of cross. Must be one of:"outcross" for full-sibs;"f2 intercross" for an F2 intercross progeny;"f2 backcross";"ri self" for recombinant inbred lines by self-mating; or"ri sib" for recombinant inbred lines by sib-mating.

Value

An empty object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


C++ routine for multipoint analysis in outcrossing populations

Description

It calls C++ routine that implements the methodology of HiddenMarkov Models (HMM) to construct multipoint linkage maps inoutcrossing species

Usage

est_map_hmm_out(  geno,  error,  type,  phase,  rf.vec = NULL,  verbose = TRUE,  tol = 1e-06)

Arguments

geno

matrix of genotypes. Rows represent marker and columnsrepresent individuals.

type

a vector indicating the type of marker. For moreinformation seeread_onemap

phase

a vector indicating the linkage phases betweenmarkers. For more information seemake_seq

rf.vec

a vector containing the recombination fractioninitial values

verbose

IfTRUE, print tracing information.

tol

tolerance for the C routine, i.e., the value used toevaluate convergence.

Value

a list containing the re-estimated vector of recombinationfractions and the logarithm of the likelihood


Export genotype probabilities in MAPpoly format (input for QTLpoly)

Description

Export genotype probabilities in MAPpoly format (input for QTLpoly)

Usage

export_mappoly_genoprob(input.map)

Arguments

input.map

object of class 'sequence'

Value

object of class 'mappoly.genoprob'


Export OneMap maps to be visualized in VIEWpoly

Description

Export OneMap maps to be visualized in VIEWpoly

Usage

export_viewpoly(seqs.list)

Arguments

seqs.list

a list with 'sequence' objects

Value

object of class viewmap


Extract allele counts of progeny and parents of vcf file

Description

Uses vcfR package and onemap object to generates list of vectors withreference allele count and total counts for each marker and genotypes included in onemap object (only available for biallelic sites)

Usage

extract_depth(  vcfR.object = NULL,  onemap.object = NULL,  vcf.par = c("GQ", "AD", "DPR, PL", "GL"),  parent1 = "P1",  parent2 = "P2",  f1 = "F1",  recovering = FALSE)

Arguments

vcfR.object

object output from vcfR package

onemap.object

onemap object output from read_onemap, read_mapmaker or onemap_read_vcf function

vcf.par

vcf format field that contain allele counts informations, the implemented are: AD, DPR, GQ, PL, GL. AD and DPR return a list with allele depth information. GQ returns a matrix with error probability for each genotype. PL return a data.frame with genotypes probabilities for every genotype.

parent1

parent 1 identification in vcfR object

parent2

parent 2 identification in vcfR object

f1

if your cross type is f2, you must define the F1 individual

recovering

TRUE/FALSE, if TRUE evaluate all markers from vcf file, if FALSE evaluate only markers in onemap object

Value

list containing the following components:

palt

amatrix with parent 1 and 2 alternative allele counts.

pref

amatrix with parent 1 and 2 reference allele counts.

psize

amatrix with parent 1 and 2 total allele counts.

oalt

amatrix with progeny alternative allele counts.

oref

amatrix with progeny reference allele counts.

osize

amatrix with progeny total allele counts.

n.mks

total number of markers.

n.ind

total number of individuals in progeny.

inds

progeny individuals identification.

mks

markers identification.

onemap.object

same onemap.object inputted

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Filter markers based on 2pts distance

Description

Filter markers based on 2pts distance

Usage

filter_2pts_gaps(input.seq, max.gap = 10)

Arguments

input.seq

object of class sequence with ordered markers

max.gap

maximum gap measured in kosambi centimorgans allowed between adjacent markers. Markers that presents the defined distance between both adjacent neighbors will be removed.

Value

New sequence object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

object of classonemap with the rawdata.

twopt

object of classrf_2pts with the2-point analyses.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Filter markers according with a missing data threshold

Description

Filter markers according with a missing data threshold

Usage

filter_missing(  onemap.obj = NULL,  threshold = 0.25,  by = "markers",  verbose = TRUE)

Arguments

onemap.obj

an object of classonemap.

threshold

a numeric from 0 to 1 to define the threshold of missing data allowed

by

character defining if 'markers' or 'individuals' should be filtered

verbose

A logical, if TRUE it output progress statusinformation.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

error

matrix containing HMM emission probabilities

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

  data(onemap_example_out)  filt_obj <- filter_missing(onemap_example_out, threshold=0.25)

Function filter genotypes by genotype probability

Description

Function filter genotypes by genotype probability

Usage

filter_prob(onemap.obj = NULL, threshold = 0.8, verbose = TRUE)

Arguments

onemap.obj

an object of classonemap.

threshold

a numeric from 0 to 1 to define the threshold for the probability of the called genotype (highest probability)

verbose

IfTRUE, print tracing information.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

error

matrix containing HMM emission probabilities

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

  data(onemap_example_out)  filt_obj <- filter_prob(onemap_example_out, threshold=0.8)

Allocate markers into bins

Description

Function to allocate markers with redundant information into bins.Within each bin, the pairwise recombination fraction between markers is zero.

Usage

find_bins(input.obj, exact = TRUE)

Arguments

input.obj

an object of classonemap.

exact

logical. IfTRUE, it only allocates markers withthe exact same information into bins, including missing data; ifFALSE, missing data are not considered when allocating markers.In the latter case, the marker with the lowest amount of missing data istaken as the representative marker on that bin.

Value

An object of classonemap_bin, which is a list containing thefollowing components:

bins

a list containing the bins. Each element ofthe list is a table whose lines indicate the name of the marker, the bin inwhich that particular marker was allocated and the percentage of missing data.The name of each element of the list corresponds to the marker with the loweramount of missing data among those on the bin

n.mar

total number of markers.

n.ind

number individuals

exact.search

logical; indicates ifthe search was performed with the argumentexact=TRUE orexact=FALSE

Author(s)

Marcelo Mollinari,mmollina@usp.br

See Also

create_data_bins

Examples

  data("vcf_example_out")  (bins<-find_bins(vcf_example_out, exact=FALSE))

Function to divide the sequence in batches with user defined size

Description

Function to divide the sequence in batches with user defined size

Usage

generate_overlapping_batches(input.seq, size = 50, overlap = 15)

Arguments

input.seq

an object of classsequence.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches


Assign markers to linkage groups

Description

Identifies linkage groups of markers, using results from two-point(pairwise) analysis and thetransitive property of linkage.

Usage

group(input.seq, LOD = NULL, max.rf = NULL, verbose = TRUE)

Arguments

input.seq

an object of classsequence.

LOD

a (positive) real number used as minimum LOD score(threshold) to declare linkage.

max.rf

a real number (usually smaller than 0.5) used asmaximum recombination fraction to declare linkage.

verbose

logical. IfTRUE, current progress is shown;ifFALSE, no output is produced.

Details

If the arguments specifying thresholds used to group markers, i.e., minimumLOD Score and maximum recombination fraction, areNULL (default),the values used are those contained in objectinput.seq. If notusingNULL, the new values override the ones in objectinput.seq.

Value

Returns an object of classgroup, which is a listcontaining the following components:

data.name

name ofthe object of classonemap that contains the rawdata.

twopt

name of the object of classrf.2tsused as input, i.e., containing information used to assignmarkers to linkage groups.

marnames

marker names,according to the input file.

n.mar

total number ofmarkers.

LOD

minimum LOD Score to declare linkage.

max.rf

maximum recombination fraction to declarelinkage.

n.groups

number of linkage groups found.

groups

number of the linkage group to which each markeris assigned.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com andMarcelo Mollinari,mmollina@usp.br

References

Lincoln, S. E., Daly, M. J. and Lander, E. S. (1993)Constructing genetic linkage maps with MAPMAKER/EXP Version3.0: a tutorial and reference manual.A WhiteheadInstitute for Biomedical Research Technical Report.

See Also

rf_2pts andmake_seq

Examples

  data(onemap_example_out)  twopts <- rf_2pts(onemap_example_out)  all.data <- make_seq(twopts,"all")  link_gr <- group(all.data)  link_gr  print(link_gr, details=FALSE) #omit the names of the markers

Assign markers to preexisting linkage groups

Description

Identifies linkage groups of markers combining inputsequences objects withunlinked markers fromrf_2pts object. The results from two-point(pairwise) analysis and thetransitive property of linkage are used forgrouping, asgroup function.

Usage

group_seq(  input.2pts,  seqs = "CHROM",  unlink.mks = "all",  repeated = FALSE,  LOD = NULL,  max.rf = NULL,  min_mks = NULL)

Arguments

input.2pts

an object of classrf_2pts.

seqs

a list of objects of classsequence or the string"CHROM" if there isCHROM information available in the inputdata file.

unlink.mks

a object of classsequence with the number ofthe markers to be grouped with the preexisting sequences defined byseqsparameter. Using the string "all", all remaining markers oftherf_2pts object will be tested.

repeated

logical. IfTRUE, markers grouped in more thanone of the sequences are kept in the output sequences. IfFALSE,they are removed of the output sequences.

LOD

a (positive) real number used as minimum LOD score(threshold) to declare linkage.

max.rf

a real number (usually smaller than 0.5) used asmaximum recombination fraction to declare linkage.

min_mks

integer defining the minimum number of markers that a provided sequence (seqs or CHROM) should have to be considered a group.

Details

If the arguments specifying thresholds used to group markers, i.e., minimumLOD Score and maximum recombination fraction, areNULL (default),the values used are those contained in objectinput.2pts. If notusingNULL, the new values override the ones in objectinput.2pts.

Value

Returns an object of classgroup_seq, which is a listcontaining the following components:

data.name

name ofthe object of classonemap that contains the rawdata.

twopt

name of the object of classrf.2tsused as input, i.e., containing information used to assignmarkers to linkage groups.

mk.names

marker names,according to the input file.

input.seqs

list with the numbersof the markers in each inputted sequence

input.unlink.mks

numbers ofthe unlinked markers in inputted sequence

out.seqs

list with thenumbers of the markers in each outputted sequence

n.unlinked

numberof markers that remained unlinked

n.repeated

number of markers whichrepeated in more than one group

n.mar

total number of markers evaluated

LOD

minimum LOD Score to declare linkage.

max.rf

maximumrecombination fraction to declare linkage.

sequences

list of outputtedsequences

repeated

list with the number of the markers that are repeatedin each outputted sequence

unlinked

number of the markers which remainedunlinked

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

See Also

make_seq andgroup

Examples

data(onemap_example_out) # load OneMap's fake dataset for a outcrossing populationdata(vcf_example_out) # load OneMap's fake dataset from a VCF file for a outcrossing populationcomb_example <- combine_onemap(onemap_example_out, vcf_example_out) # Combine datasetstwopts <- rf_2pts(comb_example)out_CHROM <- group_seq(twopts, seqs="CHROM", repeated=FALSE)out_CHROMseq1 <- make_seq(twopts, c(1,2,3,4,5,25,26))seq2 <- make_seq(twopts, c(8,18))seq3 <- make_seq(twopts, c(4,16,20,21,24,29))out_seqs <- group_seq(twopts, seqs=list(seq1,seq2,seq3))out_seqs

Assign markers to linkage groups

Description

Identifies linkage groups of markers using the results of two-point(pairwise) analysis and UPGMA method. Function adapted from MAPpoly packagewritten by Marcelo Mollinari.

Usage

group_upgma(input.seq, expected.groups = NULL, inter = TRUE, comp.mat = FALSE)

Arguments

input.seq

an object of classmappoly.rf.matrix

expected.groups

when available, inform the number of expected linkage groups (i.e. chromosomes) for the species

inter

ifTRUE (default), plots a dendrogram highlighting theexpected groups before continue

comp.mat

ifTRUE, shows a comparison between the referencebased and the linkage based grouping, if the sequence information isavailable (default = FALSE)

Value

Returns an object of classgroup, which is a listcontaining the following components:

data.name

the referred dataset name

hc.snp

a list containing information related to the UPGMA grouping method

expected.groups

the number of expected linkage groups

groups.snp

the groups to which each of the markers belong

seq.vs.grouped.snp

comparison between the genomic group information(when available) and the groups provided bygroup_upgma

LOD

minimum LOD Score to declare linkage.

max.rf

maximum recombination fraction to declare linkage.

twopt

name of the object of classrf.2tsused as input, i.e., containing information used to assignmarkers to linkage groups.

Author(s)

Marcelo Mollinari,mmollin@ncsu.edu

Cristiane Tanigutichtaniguti@tamu.edu

References

Mollinari, M., and Garcia, A. A. F. (2019) Linkageanalysis and haplotype phasing in experimental autopolyploidpopulations with high ploidy level using hidden Markovmodels, _G3: Genes, Genomes, Genetics_.doi:10.1534/g3.119.400378

Examples

 data("vcf_example_out") twopts <- rf_2pts(vcf_example_out) input.seq <- make_seq(twopts, "all") lgs <- group_upgma(input.seq, expected.groups = 3, comp.mat=TRUE, inter = FALSE) plot(lgs)

Apply Haldane mapping function

Description

Apply Haldane mapping function

Usage

haldane(rcmb)

Arguments

rcmb

vector of recombination fraction values

Value

vector with centimorgan values


Keep in the onemap and twopts object only markers in the sequences

Description

Keep in the onemap and twopts object only markers in the sequences

Usage

keep_only_selected_mks(list.sequences = NULL)

Arguments

list.sequences

a list of objects 'sequence'

Value

a list of objects 'sequences' with internal onemap and twopts objects reduced

Author(s)

Cristiane Taniguti


Apply Kosambi mapping function

Description

Apply Kosambi mapping function

Usage

kosambi(rcmb)

Arguments

rcmb

vector of recombination fraction values

Value

vector with centimorgan values


Load list of sequences saved by save_onemap_sequences

Description

Load list of sequences saved by save_onemap_sequences

Usage

load_onemap_sequences(filename)

Arguments

filename

name of the file to be loaded


Create a sequence of markers based on other OneMap object types

Description

Makes a sequence of markers based on an object of another type.

Usage

make_seq(input.obj, arg = NULL, phase = NULL, data.name = NULL, twopt = NULL)

Arguments

input.obj

an object of classonemap,rf_2pts,group,compare,try ororder.

arg

its value depends on the type of objectinput.obj. Foraonemap object,arg must be a string corresponding to oneof the reference sequences on which markers are anchored (usuallychromosomes). This requires thatCHROM information be available inthe input data file. It can also be avector of integers specifyingwhich markers comprise the sequence. For an objectrf_2pts,arg can be the string "all", resulting in a sequence with allmarkers in the raw data (generally done for grouping markers); otherwise,it must be avector of integers specifying which markers comprisethe sequence. For an object of classgroup,arg must be aninteger specifying the group. For acompare object,arg isan integer indicating the corresponding order (arranged according to thelikelihood); ifNULL (default), the best order is taken. For anobject of classtry,arg must be an integer less than orequal to the length of the original sequence plus one; the sequenceobtained will be that with the additional marker in the position indicatedbyarg. Finally, for anorder object,arg is astring: "safe" means the order that contains only markers mapped with theprovided threshold; "force" means the order with all markers.

phase

its value is also dependent on the type ofinput.obj.For anrf_2pts oronemap object,phase can be avector with user- defined linkage phases (its length is equal to thenumber of markers minus one); ifNULL (default), other functions willtry to find the best linkage phases. For example, ifphase takes onthe vectorc(1,2,3,4), the sequence of linkage phases will becoupling/coupling, coupling/repulsion, repulsion/coupling andrepulsion/repulsion for a sequence of five markers. Ifinput.obj isof classcompare ortry, this argument indicates whichcombination of linkage phases should be chosen, for the particular ordergiven by argumentarg. In both cases,NULL (default) makes thebest combination to be taken. Ifinput.obj is of class,group,group.upgma ororder, this argument has no effect.

data.name

the object whichcontains the raw data. This does not have to be defined by theuser: it is here for compatibility issues when callingmake_seq frominside other functions.

twopt

the object whichcontains the two-point information. This does not have to be defined by theuser: it is here for compatibility issues when callingmake_seq frominside other functions.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

object of classonemap with the rawdata.

twopt

object of classrf_2pts with the2-point analyses.

Author(s)

Gabriel Margarido,gramarga@gmail.com

References

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M.J., Lincoln, S. E. and Newburg, L. (1987) MAPMAKER: An interactive computerpackage for constructing primary genetic linkage maps of experimental andnatural populations.Genomics 1: 174-181.

See Also

compare,try_seq,order_seq andmap.

Examples

  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  all_mark <- make_seq(twopt,1:30) # same as above, for this data set  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.ord <- order_seq(LG1)  (LG1.final <- make_seq(LG1.ord)) # safe order  (LG1.final.all <- make_seq(LG1.ord,"force")) # forced order  markers <- make_seq(twopt,c(2,3,12,14))  markers.comp <- compare(markers)  (base.map <- make_seq(markers.comp))  base.map <- make_seq(markers.comp,1,1) # same as above  (extend.map <- try_seq(base.map,30))  (base.map <- make_seq(extend.map,5)) # fifth position is the best

Construct the linkage map for a sequence of markers

Description

Estimates the multipoint log-likelihood, linkage phases and recombinationfrequencies for a sequence of markers in a given order.

Usage

map(  input.seq,  tol = 1e-04,  verbose = FALSE,  rm_unlinked = FALSE,  phase_cores = 1,  parallelization.type = "PSOCK",  global_error = NULL,  genotypes_errors = NULL,  genotypes_probs = NULL)

Arguments

input.seq

an object of classsequence.

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

verbose

IfTRUE, print tracing information.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and returns a vector with remaining marker numbers (useful for mds_onemap and map_avoid_unlinked functions).

phase_cores

number of computer cores to be used in analysis

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

global_error

single value to be considered as error probability in HMM emission function

genotypes_errors

matrix individuals x markers with error values for each marker

genotypes_probs

table containing the probability distribution for each combination of marker × individual. Each line on this table represents the combination of one marker with one individual, and the respective probabilities.The table should contain four three columns (prob(AA), prob(AB) and prob(BB)) and individuals*markers rows.

Details

Markers are mapped in the order defined in the objectinput.seq. Ifthis object also contains a user-defined combination of linkage phases,recombination frequencies and log-likelihood are estimated for thatparticular case. Otherwise, the best linkage phase combination is alsoestimated. The multipoint likelihood is calculated according to Wu et al.(2002b)(Eqs. 7a to 11), assuming that the recombination fraction is thesame in both parents. Hidden Markov chain codes adapted from Broman et al.(2008) were used.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Adapted from Karl Broman (package 'qtl') by Gabriel R A Margarido,gramarga@usp.br and Marcelo Mollinari,mmollina@gmail.com,with minor changes by Cristiane Taniguti and Bastian Schiffthaler

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Jiang, C. and Zeng, Z.-B. (1997). Mapping quantitative trait loci withdominant and missing markers in various crosses from two inbred lines.Genetica 101: 47-58.

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M. J., Lincoln,S. E. and Newburg, L. (1987) MAPMAKER: An interactive computer package forconstructing primary genetic linkage maps of experimental and naturalpopulations.Genomics 1: 174-181.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkage mapping ofsex-specific differences.Genetical Research 79: 85-96

See Also

make_seq

Examples

  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  markers <- make_seq(twopt,c(30,12,3,14,2)) # correct phases  map(markers)  markers <- make_seq(twopt,c(30,12,3,14,2),phase=c(4,1,4,3)) # incorrect phases  map(markers)

Repeat HMM if map find unlinked marker

Description

Repeat HMM if map find unlinked marker

Usage

map_avoid_unlinked(  input.seq,  size = NULL,  overlap = NULL,  phase_cores = 1,  tol = 1e-04,  parallelization.type = "PSOCK",  max.gap = FALSE,  global_error = NULL,  genotypes_errors = NULL,  genotypes_probs = NULL)

Arguments

input.seq

object of class sequence

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

max.gap

the marker will be removed if it have gaps higher than this defined threshold in both sides

global_error

single value to be considered as error probability in HMM emission function

genotypes_errors

matrix individuals x markers with error values for each marker

genotypes_probs

table containing the probability distribution for each combination of marker × individual. Each line on this table represents the combination of one marker with one individual, and the respective probabilities.The table should contain four three columns (prob(AA), prob(AB) and prob(BB)) and individuals*markers rows.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Examples

  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  markers <- make_seq(twopt,c(30,12,3,14,2)) # correct phases  map_avoid_unlinked(markers)  markers <- make_seq(twopt,c(30,12,3,14,2),phase=c(4,1,4,3)) # incorrect phases  map_avoid_unlinked(markers)

Mapping overlapping batches

Description

Apply the batch mapping algorithm using overlapping windows.

Usage

map_overlapping_batches(  input.seq,  size = 50,  overlap = 15,  phase_cores = 1,  verbose = FALSE,  seeds = NULL,  tol = 1e-04,  rm_unlinked = TRUE,  max.gap = FALSE,  parallelization.type = "PSOCK")

Arguments

input.seq

an object of classsequence.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

verbose

A logical, if TRUE its output progress statusinformation.

seeds

A vector of phase information used as seeds for the firstbatch

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and map is performed again.

max.gap

the marker will be removed if it have gaps higher than this defined threshold in both sides

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

Details

This algorithm implements the overlapping batch maps for high densitymarker sets. The mapping problem is reduced to a number of subsets (batches)which carry information forward in order to more accurately estimaterecombination fractions and phasing. It is a adapted version ofmap.overlapping.batches function of BatchMap package. The main differences arethat this onemap version do not have the option to reorder the markers according to ripple algorithm and, if the it finds markers that do not reach the linkagecriterias, the algorithm remove the problematic marker and repeat the analysis.Than, the output map can have few markers compared with the input.seq.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classoutcross with the rawdata.

twopt

name of the object of classrf.2pts with the2-point analyses.

See Also

pick_batch_sizes,map


Perform map using background objects with only selected markers. It saves ram memory during the procedure.It is useful if dealing with many markers in total data set.

Description

Perform map using background objects with only selected markers. It saves ram memory during the procedure.It is useful if dealing with many markers in total data set.

Usage

map_save_ram(  input.seq,  tol = 1e-04,  verbose = FALSE,  rm_unlinked = FALSE,  phase_cores = 1,  size = NULL,  overlap = NULL,  parallelization.type = "PSOCK",  max.gap = FALSE)

Arguments

input.seq

object of class sequence

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

verbose

IfTRUE, print tracing information.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and returns a vector with remaining marker numbers (useful for mds_onemap and map_avoid_unlinked functions).

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

max.gap

the marker will be removed if it have gaps higher than this defined threshold in both sides


Simulated data from a F2 population

Description

Simulated data set from a F2 population.

Usage

data("mapmaker_example_f2")

Format

The format is:List of 8$ geno : num [1:200, 1:66] 1 3 2 2 1 0 3 1 1 3 .....- attr(*, "dimnames")=List of 2.. ..$ : NULL.. ..$ : chr [1:66] "M1" "M2" "M3" "M4" ...$ n.ind : num 200$ n.mar : num 66$ segr.type : chr [1:66] "A.H.B" "C.A" "D.B" "C.A" ...$ segr.type.num: num [1:66] 1 3 2 3 3 2 1 3 2 1 ...$ input : chr "/home/cristiane/R/x86_64-pc-linux-gnu-library/3.4/onemap/extdata/mapmaker_example_f2.raw"$ n.phe : num 1$ pheno : num [1:200, 1] 37.6 36.4 37.2 35.8 37.1 .....- attr(*, "dimnames")=List of 2.. ..$ : NULL.. ..$ : chr "Trait_1"- attr(*, "class")= chr [1:2] "onemap" "f2"

Details

A total of 200 individuals were genotyped for 66 markers (36co-dominant, i.e. a, ab or b and 30 dominant i.e. c or a and d or b) with 15% of missing data. There is one quantitative phenotype to show howto useonemap output asR\qtl andQTL Cartographer input. Also, it is usedfor the analysis in the tutorial that comes with OneMap.

Examples

data(mapmaker_example_f2)# perform two-point analysestwopts <- rf_2pts(mapmaker_example_f2)twopts

Informs the segregation patterns of markers

Description

Informs the type of segregation of all markers from an object of classsequence. For outcross populations it uses the notation byWuet al., 2002. For backcrosses, F2s and RILs, it uses thetraditional notation from MAPMAKER i.e. AA, AB, BB, not AA and not BB.

Usage

marker_type(input.seq)

Arguments

input.seq

an object of classsequence.

Details

The segregation types are (Wu et al., 2002):

Type Cross Segregation
A.1 ab x cd 1:1:1:1
A.2ab x ac 1:1:1:1
A.3 ab x co 1:1:1:1
A.4 ao x bo 1:1:1:1
B1.5 ab x ao 1:2:1
B2.6 ao x ab1:2:1
B3.7 ab x ab 1:2:1
C8 ao x ao 3:1
D1.9 ab x cc 1:1
D1.10 ab x aa 1:1
D1.11ab x oo 1:1
D1.12 bo x aa 1:1
D1.13 ao x oo 1:1
D2.14 cc x ab 1:1
D2.15 aa x ab 1:1
D2.16 oo x ab 1:1
D2.17 aa x bo 1:1
D2.18 oo x ao 1:1

Value

data.frame with segregation types of all markers in thesequence are displayed on the screen.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com

References

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002)Simultaneous maximum likelihood estimation of linkage and linkage phases inoutcrossing species.Theoretical Population Biology 61: 349-363.

See Also

make_seq

Examples

 data(onemap_example_out) twopts <- rf_2pts(onemap_example_out) markers.ex <- make_seq(twopts,c(3,6,8,12,16,25)) marker_type(input.seq = markers.ex) # segregation type for some markers data(onemap_example_f2) twopts <- rf_2pts(onemap_example_f2) all_mrk<-make_seq(twopts, "all") lgs<-group(all_mrk) lg1<-make_seq(lgs,1) marker_type(lg1) # segregation type for linkage group 1

OneMap interface with MDSMap package with option for multipoint distances estimation

Description

For a given sequence of markers, apply mds method described in Preedy and Hackett (2016)using MDSMap package to ordering markers and estimates the genetic distances with OneMapmultipoint approach. Also gives MDSMap input file format for directly analysis in this package.

Usage

mds_onemap(  input.seq,  out.file = NULL,  p = NULL,  ispc = TRUE,  displaytext = FALSE,  weightfn = "lod2",  mapfn = "haldane",  ndim = 2,  rm_unlinked = TRUE,  size = NULL,  overlap = NULL,  phase_cores = 1,  tol = 1e-05,  hmm = TRUE,  parallelization.type = "PSOCK")

Arguments

input.seq

an object of classsequence

out.file

path to the generated MDSMap input file.

p

Integer - the penalty for deviations from the sphere - higher pforces points more closely onto a sphere.

ispc

Logical determining the method to be used to estimate the map. By default this is TRUE and the method of principal curves will be used. If FALSE then the constrained MDS method will be used.

displaytext

Shows markers names in analysis graphic view

weightfn

Character string specifying the values to use for the weightmatrix in the MDS 'lod2' or 'lod'.

mapfn

Character string specifying the map function to use on therecombination fractions 'haldane' is default, 'kosambi' or 'none'.

ndim

number of dimensions to be considered in the multidimensional scaling procedure (default = 2)

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and mds is performed again.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

hmm

logical defining if the HMM must be applied to estimate multipointgenetic distances

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

Details

For better description about MDS method, see MDSMap package vignette.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

References

Preedy, K. F. and Hackett, C. A. (2016). A rapid marker ordering approach for high-densitygenetic linkage maps in experimental autotetraploid populations using multidimensionalscaling.Theoretical and Applied Genetics 129: 2117-2132

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia, A. A. F.(2009) Evaluation of algorithms used to order markers on genetics maps.Heredity 103: 494-502.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkage mapping ofsex-specific differences.Genetical Research 79: 85-96

See Also

https://CRAN.R-project.org/package=MDSMap.


Simulated data from a backcross population

Description

Simulated data set from a backcross population.

Usage

data(onemap_example_bc)

Format

The format is:List of 10$ geno : num [1:150, 1:67] 1 2 1 1 2 1 2 1 1 2 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:150] "ID1" "ID2" "ID3" "ID4" ..... ..$ : chr [1:67] "M1" "M2" "M3" "M4" ...$ n.ind : int 150$ n.mar : int 67$ segr.type : chr [1:67] "A.H" "A.H" "A.H" "A.H" ...$ segr.type.num: logi [1:67] NA NA NA NA NA NA ...$ n.phe : int 1$ pheno : num [1:150, 1] 40.8 39.5 37.9 34.2 38.9 .....- attr(*, "dimnames")=List of 2.. ..$ : NULL.. ..$ : chr "Trait_1"$ CHROM : NULL$ POS : NULL$ input : chr "onemap_example_bc.raw"- attr(*, "class")= chr [1:2] "onemap" "backcross"

Details

A total of 150 individuals were genotyped for 67 markers with 15% ofmissing data. There is one quantitative phenotype to show howto useonemap output asR\qtl input.

Author(s)

Marcelo Mollinari,mmollina@usp.br

See Also

read_onemap andread_mapmaker.

Examples

data(onemap_example_bc)# perform two-point analysestwopts <- rf_2pts(onemap_example_bc)twopts

Simulated data from a F2 population

Description

Simulated data set from a F2 population.

Usage

data("onemap_example_f2")

Format

The format is:List of 10$ geno : num [1:200, 1:66] 1 3 2 2 1 0 3 1 1 3 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:200] "IND1" "IND2" "IND3" "IND4" ..... ..$ : chr [1:66] "M1" "M2" "M3" "M4" ...$ n.ind : int 200$ n.mar : int 66$ segr.type : chr [1:66] "A.H.B" "C.A" "D.B" "C.A" ...$ segr.type.num: num [1:66] 1 3 2 3 3 2 1 3 2 1 ...$ n.phe : int 1$ pheno : num [1:200, 1] 37.6 36.4 37.2 35.8 37.1 .....- attr(*, "dimnames")=List of 2.. ..$ : NULL.. ..$ : chr "Trait_1"$ CHROM : NULL$ POS : NULL$ input : chr "/home/cristiane/R/x86_64-pc-linux-gnu-library/3.4/onemap/extdata/onemap_example_f2.raw"- attr(*, "class")= chr [1:2] "onemap" "f2"

Details

A total of 200 individuals were genotyped for 66 markers (36co-dominant, i.e. a, ab or b and 30 dominant i.e. c or a and d or b) with 15% of missing data. There is one quantitative phenotype to show howto useonemap output asR\qtl andQTL Cartographer input. Also, it is usedfor the analysis in the tutorial that comes with OneMap.

Examples

data(onemap_example_f2)plot(onemap_example_f2)

Data from a full-sib family derived from two outbred parents

Description

Simulated data set for an outcross, i.e., an F1 population obtained bycrossing two non-homozygous parents.

Usage

data(onemap_example_out)

Format

An object of classonemap.

Details

A total of 100 F1 individuals were genotyped for 30 markers. The datacurrently contains only genotype information (no phenotypes). It isincluded to be used as a reference in order to understand how a datafile needs to be. Also, it is used for the analysis in the tutorialthat comes with OneMap.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com

See Also

read_onemap for details about objects of classonemap.

Examples

data(onemap_example_out)# perform two-point analysestwopts <- rf_2pts(onemap_example_out)twopts

Simulated data from a RIL population produced by selfing.

Description

Simulated biallelic data set for anri self population.

Usage

data("onemap_example_riself")

Format

The format is:List of 10$ geno : num [1:100, 1:68] 3 1 3 1 1 1 1 1 1 1 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:100] "ID1" "ID2" "ID3" "ID4" ..... ..$ : chr [1:68] "M1" "M2" "M3" "M4" ...$ n.ind : int 100$ n.mar : int 68$ segr.type : chr [1:68] "A.B" "A.B" "A.B" "A.B" ...$ segr.type.num: logi [1:68] NA NA NA NA NA NA ...$ n.phe : int 0$ pheno : NULL$ CHROM : NULL$ POS : NULL$ input : chr "onemap_example_riself.raw"- attr(*, "class")= chr [1:2] "onemap" "riself"

Details

A total of 100 F1 individuals were genotyped for 68 markers. The datacurrently contains only genotype information (no phenotypes). It isincluded to be used as a reference in order to understand how a datafile needs to be.

Author(s)

Cristiane Taniguti,chtaniguti@usp.br

See Also

read_onemap for details about objects of classonemap.

Examples

data(onemap_example_riself)plot(onemap_example_riself)

Convert vcf file to onemap object

Description

Converts data from a vcf file to onemap initial object, while identify the appropriate marker segregation patterns.

Usage

onemap_read_vcfR(  vcf = NULL,  vcfR.object = NULL,  cross = NULL,  parent1 = NULL,  parent2 = NULL,  f1 = NULL,  only_biallelic = TRUE,  output_info_rds = NULL,  verbose = TRUE)

Arguments

vcf

string defining the path to VCF file;

vcfR.object

object of class vcfR;

cross

type of cross. Must be one of:"outcross" for full-sibs;"f2 intercross" for an F2 intercross progeny;"f2 backcross";"ri self" for recombinant inbred lines by self-mating; or"ri sib" for recombinant inbred lines by sib-mating.

parent1

string specifying sample ID of the first parent. If f2 backcross population, define here the ID of the backcrossed parent.

parent2

string specifying sample ID of the second parent.

f1

string if you are working with f2 intercross or backcross populations you may have f1 parents in you vcf, specify its ID here

only_biallelic

if TRUE (default) only biallelic markers are considered, if FALSE multiallelic markers are included.

output_info_rds

define a name for the file with alleles information.

verbose

A logical, if TRUE it output progress statusinformation.

Details

Only biallelic SNPs and indels for diploid variant sites are considered.

Genotype information on the parents is required for all cross types. Forfull-sib progenies, both outbred parents must be genotyped. For backcrosses,F2 intercrosses and recombinant inbred lines, theoriginal inbredlines must be genotyped. Particularly for backcross progenies, therecurrent line must be provided as the first parent in the functionarguments.

Marker type is determined based on parental genotypes. Variants for which parentgenotypes cannot be determined are discarded.

Reference sequence ID and position for each variant site are also stored.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

error

matrix containing HMM emission probabilities

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

See Also

read_onemap for a description of the output object of class onemap.

Examples

data <- onemap_read_vcfR(vcf=system.file("extdata/vcf_example_out.vcf.gz", package = "onemap"),                 cross="outcross",                 parent1=c("P1"),                 parent2=c("P2"))

Order the markers in a sequence using the genomic position

Description

Order the markers in a sequence using the genomic position

Usage

ord_by_geno(input.seq)

Arguments

input.seq

object of class 'sequence'

Value

An object of classsequence

Author(s)

Cristiane Taniguti


Search for the best order of markers combining compare and try_seqfunctions

Description

For a given sequence of markers, this function first uses thecompare function to create a framework for a subset of informativemarkers. Then, it tries to map remaining ones using thetry_seqfunction.

Usage

order_seq(  input.seq,  n.init = 5,  subset.search = c("twopt", "sample"),  subset.n.try = 30,  subset.THRES = 3,  twopt.alg = c("rec", "rcd", "ser", "ug"),  THRES = 3,  touchdown = FALSE,  tol = 0.1,  rm_unlinked = FALSE,  verbose = FALSE)

Arguments

input.seq

an object of classsequence.

n.init

the number of markers to be used in thecompare step(defaults to 5).

subset.search

a character string indicating which method should beused to search for a subset of informative markers for thecompare step. It is used for backcross,F_2 or RILpopulations, but not for outcrosses. See theDetails section.

subset.n.try

integer. The number of times to repeat the subsetsearch procedure. It is only used ifsubset.search=="sample". SeetheDetails section.

subset.THRES

numerical. The threshold for the subset searchprocedure. It is only used ifsubset.search=="sample". See theDetails section.

twopt.alg

a character string indicating which two-point algorithmshould be used ifsubset.search=="twopt". See theDetailssection.

THRES

threshold to be used when positioning markers in thetry_seq step.

touchdown

logical. IfFALSE (default), thetry_seqstep is run only once, with the value ofTHRES. IfTRUE,try_seq runs withTHRES and then once more, withTHRES-1. The latter calculations take longer, but usually are ableto map more markers.

tol

tolerance number for the C routine, i.e., the value used toevaluate convergence of the EM algorithm.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and returns a vector with remaining marker numbers (useful for mds_onemap and map_avoid_unlinked functions).

verbose

A logical, if TRUE its output progress statusinformation.

Details

For outcrossing populations, the initial subset and the order in whichremaining markers will be used in thetry_seq step is given by thedegree of informativeness of markers (i.e markers of type A, B, C and D, inthis order).

For backcrosses, F2s or RILs, two methods can be used forchoosing the initial subset: i)"sample" randomly chooses a numberof markers, indicated byn.init, and calculates the multipointlog-likelihood of the\frac{n.init!}{2} possible orders.If the LOD Score of the second best order is greater thansubset.THRES, than it takes the best order to proceed with thetry_seq step. If not, the procedure is repeated. The maximum numberof times to repeat this procedure is given by thesubset.n.tryargument. ii)"twopt" uses a two-point based algorithm, given by theoption"twopt.alg", to construct a two-point based map. The optionsare"rec" for RECORD algorithm,"rcd" for Rapid ChainDelineation,"ser" for Seriation and"ug" for UnidirectionalGrowth. Then, equally spaced markers are taken from this map. The"compare" step will then be applied on this subset of markers.

In both cases, the order in which the other markers will be used in thetry_seq step is given by marker types (i.e. co-dominant beforedominant) and by the missing information on each marker.

After running thecompare andtry_seq steps, which result ina "safe" order, markers that could not be mapped are "forced" into the map,resulting in a map with all markers positioned.

Value

An object of classorder, which is a list containing thefollowing components:

ord

an object of classsequencecontaining the "safe" order.

mrk.unpos

avector withunpositioned markers (if they exist).

LOD.unpos

amatrixwith LOD-Scores for unmapped markers, if any, for each position in the"safe" order.

THRES

the same as the input value, just forprinting.

ord.all

an object of classsequence containing the"forced" order, i.e., the best order with all markers.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Gabriel R A Margarido,gramarga@usp.br and MarceloMollinari,mmollina@gmail.com

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Jiang, C. and Zeng, Z.-B. (1997). Mapping quantitative trait loci withdominant and missing markers in various crosses from two inbred lines.Genetica 101: 47-58.

Lander, E. S. and Green, P. (1987). Construction of multilocus geneticlinkage maps in humans.Proc. Natl. Acad. Sci. USA 84: 2363-2367.

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M. J., Lincoln,S. E. and Newburg, L. (1987) MAPMAKER: An interactive computer package forconstructing primary genetic linkage maps of experimental and naturalpopulations.Genomics 1: 174-181.

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia, A. A. F.(2009) Evaluation of algorithms used to order markers on genetics maps.Heredity 103: 494-502.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkage mapping ofsex-specific differences.Genetical Research 79: 85-96

See Also

make_seq,compare andtry_seq.

Examples

  #outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG2 <- make_seq(groups,2)  LG2.ord <- order_seq(LG2,touchdown=TRUE)  LG2.ord  make_seq(LG2.ord) # get safe sequence  make_seq(LG2.ord,"force") # get forced sequence

Generates data.frame with parents estimated haplotypes

Description

Generates data.frame with parents estimated haplotypes

Usage

parents_haplotypes(  ...,  group_names = NULL,  map.function = "kosambi",  ref_alt_alleles = FALSE)

Arguments

...

objects of class sequence

group_names

vector of characters defining the group names

map.function

"kosambi" or "haldane" according to which was used to build the map

ref_alt_alleles

TRUE to return parents haplotypes as reference and alternative ref_alt_alleles codification

Value

data.frame with group ID (group), marker number (mk.number) and names (mk.names), position in centimorgan (dist) and parents haplotypes (P1_1, P1_2, P2_1, P2_2)

Author(s)

Getulio Caixeta Ferreira,getulio.caifer@gmail.com

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

data("onemap_example_out")twopts <- rf_2pts(onemap_example_out)lg1 <- make_seq(twopts, 1:5)lg1.map <- map(lg1)parents_haplotypes(lg1.map)

Picking optimal batch size values

Description

Suggest an optimal batch size value for use inmap_overlapping_batches

Usage

pick_batch_sizes(input.seq, size = 50, overlap = 15, around = 5)

Arguments

input.seq

an object of classsequence.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

around

The range around the center which is maximally allowedto be searched.

Value

An integer value for the size which most evenly divides batches. Incase of ties, bigger batch sizes are preferred.

Author(s)

Bastian Schiffthaler,bastian.schiffthaler@umu.se

See Also

map_overlapping_batches

Examples

  LG <- structure(list(seq.num = seq(1,800)), class = "sequence")  batchsize <- pick_batch_sizes(LG, 50, 19)

Show the results of grouping procedure

Description

It shows the linkage groups as well as the unlinked markers.

Usage

## S3 method for class 'group.upgma'plot(x, ...)

Arguments

x

an object of class group.upgma

...

currently ignored

Value

NULL


Draw a graphic of raw data for any OneMap population

Description

Shows a heatmap (in ggplot2, a graphic of geom "tile") for raw data.Lines correspond to markers and columns to individuals.The function can plot a graph for all marker types, depending of the cross type (dominant/codominant markers, in all combinations).The function receives a onemap object of classonemap, reads informationfrom genotypes from this object, converts it to a long dataframe formatusing function melt() from package reshape2() or internal function create_dataframe_for_plot_outcross(), converts numbers from the objectto genetic notation (according to the cross type), then plots the graphic.If there is more than 20 markers, removes y labelsFor outcross populations, it can show all markers together, or it can split them according the segregationpattern.

Usage

## S3 method for class 'onemap'plot(x, all = TRUE, ...)

Arguments

x

an object of classonemap, with data and additional information

all

a TRUE/FALSE option to indicate if results will beplotted together (if TRUE) or splitted based on theirsegregation pattern. Only used for outcross populations.

...

currently ignored

Value

a ggplot graphic

Examples

# library(ggplot2)data(onemap_example_bc) # Loads a fake backcross dataset installed with onemapplot(onemap_example_bc) # This will show you the graph# You can store the graphic in an object, then save it with a number of properties# For details, see the help of ggplot2's function ggsave()g <- plot(onemap_example_bc)data(onemap_example_f2) # Loads a fake backcross dataset installed with onemapplot(onemap_example_f2) # This will show you the graph# You can store the graphic in an object, then save it with a number of properties# For details, see the help of ggplot2's function ggsave()g <- plot(onemap_example_f2)data(onemap_example_out) # Loads a fake full-sib dataset installed with onemapplot(onemap_example_out) # This will show you the graph for all markersplot(onemap_example_out, all=FALSE) # This will show you the graph splitted for marker types# You can store the graphic in an object, then save it.# For details, see the help of ggplot2's function ggsave()g <- plot(onemap_example_out, all=FALSE)

Plots progeny haplotypes

Description

Figure is generated with the haplotypes for each selected individual. As a representation, the recombination breakpoints are here considered to be in the mean point of the distance between two markers. It is important to highlight that it did not reflects the exact breakpoint position, specially if the genetic map have low resolution.

Usage

## S3 method for class 'onemap_progeny_haplotypes'plot(  x,  col = NULL,  position = "stack",  show_markers = TRUE,  main = "Genotypes",  ncol = 4,  ...)

Arguments

x

object of class onemap_progeny_haplotypes

col

Color of parents' homologous.

position

"split" or "stack"; if "split" (default) the alleles' are plotted separately. if "stack" the parents' alleles are plotted together.

show_markers

logical; ifTRUE, the markers (default) are plotted.

main

An overall title for the plot; default isNULL.

ncol

number of columns of the facet_wrap

...

currently ignored

Value

a ggplot graphic

Author(s)

Getulio Caixeta Ferreira,getulio.caifer@gmail.com

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

 data("onemap_example_out")twopts <- rf_2pts(onemap_example_out)lg1 <- make_seq(twopts, 1:5)lg1.map <- map(lg1)plot(progeny_haplotypes(lg1.map))

Plot recombination breakpoints counts for each individual

Description

Plot recombination breakpoints counts for each individual

Usage

## S3 method for class 'onemap_progeny_haplotypes_counts'plot(x, by_homolog = FALSE, n.graphics = NULL, ncol = NULL, ...)

Arguments

x

object of class onemap_progeny_haplotypes_counts

by_homolog

logical, if TRUE plots counts by homolog (two for each individuals), if FALSE plots total counts by individual

n.graphics

integer defining the number of graphics to be plotted, they separate the individuals in different plots

ncol

integer defining the number of columns in plot

...

currently ignored

Value

a ggplot graphic

Examples

data("onemap_example_out")twopts <- rf_2pts(onemap_example_out)lg1 <- make_seq(twopts, 1:5)lg1.map <- map(lg1)prog.haplo <- progeny_haplotypes(lg1.map, most_likely = TRUE)plot(progeny_haplotypes_counts(prog.haplo))

Plot p-values for chi-square tests of expected segregation

Description

Draw a graphic showing the p-values (re-scaled to -log10(p-values)) associated with thechi-square tests for the expected segregation patterns for all markers in a dataset.It includes a vertical line showing the threshold for declaring statistical significanceif Bonferroni's correction is considered, as well as the percentage of markers thatwill be discarded if this criterion is used.

Usage

## S3 method for class 'onemap_segreg_test'plot(x, order = TRUE, ...)

Arguments

x

an object of class onemap_segreg_test (produced by onemap's functiontest_segregation()), i. e., after performing segregation tests

order

a variable to define if p-values will be ordered in the plot

...

currently ignored

Value

a ggplot graphic

Examples

 data(onemap_example_bc) # load OneMap's fake dataset for a backcross population BC.seg <- test_segregation(onemap_example_bc) # Applies chi-square tests print(BC.seg) # Shows the results plot(BC.seg) # Plot the graph, ordering the p-values plot(BC.seg, order=FALSE) # Plot the graph showing the results keeping the order in the dataset data(onemap_example_out) # load OneMap's fake dataset for an outcrossing population Out.seg <- test_segregation(onemap_example_out) # Applies chi-square tests print(Out.seg) # Shows the results plot(Out.seg) # Plot the graph, ordering the p-values plot(Out.seg, order=FALSE) # Plot the graph showing the results keeping the order in the dataset

Draw a graphic showing the number of markers of each segregation pattern.

Description

The function receives an object of classonemap.For outcrossing populations, it can show detailed information (all 18 possible categories),or a simplified version.

Usage

plot_by_segreg_type(x, subcateg = TRUE)

Arguments

x

an object of classonemap

subcateg

a TRUE/FALSE option to indicate if results will be plotted showingall possible categories (only for outcrossing populations)

Value

a ggplot graphic

Examples

data(onemap_example_out) #Outcrossing dataplot_by_segreg_type(onemap_example_out)plot_by_segreg_type(onemap_example_out, subcateg=FALSE)data(onemap_example_bc)plot_by_segreg_type(onemap_example_bc)data(mapmaker_example_f2)plot_by_segreg_type(mapmaker_example_f2)

Draws a physical vs cM map

Description

Provides simple genetic to physical ggplot.

Usage

plot_genome_vs_cm(map.list, mapping_function = "kosambi", group.names = NULL)

Arguments

map.list

a map, i.e. an object of classsequence with apredefined order, linkage phases, recombination fraction and likelihood;also it could be a list of maps.

mapping_function

either "kosambi" or "haldane"

group.names

vector with group name for each sequence object in the map.list

Value

ggplot with cM on x-axis and physical position on y-axis

Author(s)

Jeekin Lau,jeekinlau@gmail.com


print method for object class 'compare'

Description

print method for object class 'compare'

Usage

## S3 method for class 'compare'print(x, ...)

Arguments

x

object of class compare

...

currently ignored

Value

compare object description


Show the results of grouping procedure

Description

It shows the linkage groups as well as the unlinked markers.

Usage

## S3 method for class 'group'print(x, detailed = TRUE, ...)

Arguments

x

an object of class group

detailed

logical. IfTRUE the markers in eachlinkage group are printed.

...

currently ignored

Value

NULL


Show the results of grouping procedure

Description

It shows the linkage groups as well as the unlinked markers.

Usage

## S3 method for class 'group.upgma'print(x, ...)

Arguments

x

an object of class group.upgma

...

currently ignored

Value

NULL


Show the results of grouping markers to preexisting sequence

Description

It shows the groups sequences, the repeated markers, as well as the unlinked markers.

Usage

## S3 method for class 'group_seq'print(x, detailed = TRUE, ...)

Arguments

x

an object of class group_seq

detailed

logical. IfTRUE the markers in eachlinkage group sequence are printed.

...

currently ignored

Value

No return value, called for side effects


Print method for object class 'onemap'

Description

Print method for object class 'onemap'

Usage

## S3 method for class 'onemap'print(x, ...)

Arguments

x

object of class onemap

...

currently ignored

Value

printed information about onemap object


print method for object class 'onemap_bin'

Description

print method for object class 'onemap_bin'

Usage

## S3 method for class 'onemap_bin'print(x, ...)

Arguments

x

object of classonemap_bin

...

currently ignored

Value

No return value, called for side effects


Show the results of segregation tests

Description

It shows the results of Chisquare tests performed for all markers in a onemap objectof cross type outcross, backcross, F2 intercross or recombinant inbred lines.

Usage

## S3 method for class 'onemap_segreg_test'print(x, ...)

Arguments

x

an object of class onemap_segreg_test

...

currently ignored

Value

a dataframe with marker name, H0 hypothesis, chi-square statistics,p-values, and

Examples

 data(onemap_example_out) # Loads a fake outcross dataset installed with onemap Chi <- test_segregation(onemap_example_out) # Performs the chi-square test for all markers print(Chi) # Shows the results

Print order_seq object

Description

Print order_seq object

Usage

## S3 method for class 'order'print(x, ...)

Arguments

x

object of class order_seq

...

currently ignored

Value

printed information about order_seq object


Print method for object class 'rf_2pts'

Description

It shows the linkage groups as well as the unlinked markers.

Usage

## S3 method for class 'rf_2pts'print(x, mrk = NULL, ...)

Arguments

x

an object of classrf_2pts.

mrk

a vector containing a pair of markers, so detailedresults of the two-point analysis will be printed for them.Can be numeric or character strings indicating thenumbers/names corresponding to any markers in the input file.

...

further arguments, passed to other methods. Currently ignored.

Value

NULL


Print method for object class 'sequence'

Description

Print method for object class 'sequence'

Usage

## S3 method for class 'sequence'print(x, ...)

Arguments

x

object of class sequence

...

corrently ignored

Value

printed information about sequence object


Print method for object class 'try'

Description

Print method for object class 'try'

Usage

## S3 method for class 'try'print(x, j = NULL, ...)

Arguments

x

an object of classtry.

j

ifNULL (default), output is a summary of theresults for all possible positions of the additionalmarker. Otherwise, an integer makes detailed output to beprinted for the corresponding position. This integer must beless than or equal to the length of the original sequence plus1. @param ... further arguments, passed to othermethods. Currently ignored.

...

currently ignored

Value

NULL


Generate data.frame with genotypes estimated by HMM and its probabilities

Description

Generate data.frame with genotypes estimated by HMM and its probabilities

Usage

progeny_haplotypes(..., ind = 1, group_names = NULL, most_likely = FALSE)

Arguments

...

Map(s) or list(s) of maps. Object(s) of class sequence.

ind

vector with individual index to be evaluated or "all" to include all individuals

group_names

Names of the groups.

most_likely

logical; ifTRUE, the most likely genotype receive 1 and all the rest 0. If there are more than one most likely both receive 0.5.if FALSE (default) the genotype probability is plotted.

Value

a data.frame information: individual (ind) and marker ID, group ID (grp), position in centimorgan (pos), genotypes probabilities (prob), parents, and the parents homologs and the allele IDs.

Author(s)

Getulio Caixeta Ferreira,getulio.caifer@gmail.com

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

data("onemap_example_out")twopts <- rf_2pts(onemap_example_out)lg1 <- make_seq(twopts, 1:5)lg1.map <- map(lg1)progeny_haplotypes(lg1.map)

Plot number of breakpoints by individuals

Description

Generate graphic with the number of break points for each individual considering the most likely genotypes estimated by the HMM.Genotypes with same probability for two genotypes are removed.By now, only available for outcrossing and f2 intercross.

Usage

progeny_haplotypes_counts(x)

Arguments

x

object of class onemap_progeny_haplotypes

Value

adata.frame with columns individuals ID (ind), group ID (grp),homolog (homolog) and counts of breakpoints

Examples

data("onemap_example_out")twopts <- rf_2pts(onemap_example_out)lg1 <- make_seq(twopts, 1:5)lg1.map <- map(lg1)progeny_haplotypes_counts(progeny_haplotypes(lg1.map, most_likely = TRUE))

Rapid Chain Delineation

Description

Implements the marker ordering algorithmRapid Chain Delineation(Doerge, 1996).

Usage

rcd(  input.seq,  LOD = 0,  max.rf = 0.5,  tol = 1e-04,  rm_unlinked = TRUE,  size = NULL,  overlap = NULL,  phase_cores = 1,  hmm = TRUE,  parallelization.type = "PSOCK",  verbose = TRUE)

Arguments

input.seq

an object of classsequence.

LOD

minimum LOD-Score threshold used when constructing the pairwiserecombination fraction matrix.

max.rf

maximum recombination fraction threshold used as the LODvalue above.

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and rcd is performed again.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

hmm

logical defining if the HMM must be applied to estimate multipointgenetic distances

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

verbose

A logical, if TRUE it output progress statusinformation.

Details

Rapid Chain Delineation (RCD) is an algorithm for markerordering in linkage groups. It is not an exhaustive search method and,therefore, is not computationally intensive. However, it does not guaranteethat the best order is always found. The only requirement is a matrix withrecombination fractions between markers. Next is an excerpt from QTLCartographer Version 1.17 Manual describing theRCD algorithm(Basten et al., 2005):

The linkage group is initiated with the pair of markers having thesmallest recombination fraction. The remaining markers are placed in a“pool” awaiting placement on the map. The linkage group is extendedby adding markers from the pool of unlinked markers. Each terminal markerof the linkage group is a candidate for extension of the chain: Theunlinked marker that has the smallest recombination fraction with either isadded to the chain subject to the provision that the recombination fractionis statistically significant at a prespecified level. This process isrepeated as long as markers can be added to the chain.

After determining the order withRCD, the final map is constructedusing the multipoint approach (functionmap).

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com

References

Basten, C. J., Weir, B. S. and Zeng, Z.-B. (2005)QTLCartographer Version 1.17: A Reference Manual and Tutorial for QTLMapping.

Doerge, R. W. (1996) Constructing genetic maps by rapid chain delineation.Journal of Quantitative Trait Loci 2: 121-132.

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia, A. A. F.(2009) Evaluation of algorithms used to order markers on genetics maps.Heredity 103: 494-502.

See Also

make_seq,map

Examples

  #outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.rcd <- rcd(LG1, hmm = FALSE)  #F2 example  data(onemap_example_f2)  twopt <- rf_2pts(onemap_example_f2)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.rcd <- rcd(LG1, hmm = FALSE)  LG1.rcd

Read data from a Mapmaker raw file

Description

Imports data from a Mapmaker raw file.

Usage

read_mapmaker(file = NULL, dir = NULL, verbose = TRUE)

Arguments

file

the name of the input file which contains the data to be read.

dir

directory where the input file is located.

verbose

A logical, if TRUE it output progress statusinformation.

Details

For details about MAPMAKER files seeLincoln et al. (1993). Thecurrent version supports backcross, F2s and RIL populations. The filecan contain phenotypic data, but it will not be used in the analysis.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker inonemap fashion. Each column contains datafor a marker and each row represents an individual.

MAPMAKER/EXP fashion, i.e., 1, 2, 3: AA, AB, BB, respectively; 3, 4:BB, not BB, respectively; 1, 5: AA, not AA, respectively. Each columncontains data for a marker and each row represents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with the segregation type of each marker, asstrings. Segregation types were adapted from outcross segregationtypes, using the same notation. For details seeread_onemap.

segr.type.num

a vector with the segregation type of each marker,represented in a simplified manner as integers. Segregation types wereadapted from outcross segregation types. For details seeread_onemap.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual. Currently ignored.

error

matrix containing HMM emission probabilities

Author(s)

Adapted from Karl Broman (packageqtl) by Marcelo Mollinari,mmollina@usp.br

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Lincoln, S. E., Daly, M. J. and Lander, E. S. (1993) Constructing geneticlinkage maps with MAPMAKER/EXP Version 3.0: a tutorial and referencemanual.A Whitehead Institute for Biomedical Research TechnicalReport.

See Also

mapmaker_example_bc andmapmaker_example_f2 raw files in thepackage source.

Examples

 map_data <-read_mapmaker(file=system.file("extdata/mapmaker_example_f2.raw", package = "onemap")) #Checking 'mapmaker_example_f2' data(mapmaker_example_f2) names(mapmaker_example_f2)

Read data from all types of progenies supported by OneMap

Description

Imports data derived from outbred parents (full-sib family) or inbredparents (backcross, F2 intercross and recombinant inbred lines obtainedby self- or sib-mating). Creates an object of classonemap.

Usage

read_onemap(inputfile = NULL, dir = NULL, verbose = TRUE)

Arguments

inputfile

the name of the input file which contains the data to be read.

dir

directory where the input file is located.

verbose

A logical, if TRUE it output progress statusinformation.

Details

The file format is similar to that used byMAPMAKER/EXP(Lincoln et al., 1993). The first line indicates the cross typeand is structured asdata type {cross}, wherecrossmust be one of"outcross","f2 intercross","f2 backcross","ri self" or"ri sib". The second linecontains five integers: i) the number of individuals; ii) the number ofmarkers; iii) an indicator variable taking the value 1 if there is CHROMinformation, i.e., if markers are anchored on any reference sequence, and0 otherwise; iv) a similar 1/0 variable indicating whether there is POSinformation for markers; and v) the number of phenotypic traits.

The next line contains sample IDs, separated by empty spaces or tabs.Addition of this sample ID requirement makes it possible for separate inputdatasets to be merged.

Next comes the genotype data for all markers. Each new marker is initiatedwith a “*” (without the quotes) followed by the marker name, withoutany space between them. Each marker name is followed by the correspondingsegregation type, which may be:"A.1","A.2","A.3","A.4","B1.5","B2.6","B3.7","C.8","D1.9","D1.10","D1.11","D1.12","D1.13","D2.14","D2.15","D2.16","D2.17" or"D2.18" (without quotes), for full-sibs [seemarker_type andWu et al. (2002) for details].Other cross types have special marker types:"A.H" for backcrosses;"A.H.B" for F2 intercrosses; and"A.B" for recombinant inbredlines.

After the segregation type comes the genotype data for thecorresponding marker. Depending on the segregation type, genotypes may bedenoted byac,ad,bc,bd,a,ba,b,bc,ab ando, in several possiblecombinations. To make things easier, we have followedexactly thenotation used byWu et al. (2002). Allowed values for backcrossesarea andab; for F2 crosses they area,ab andb; for RILs they may bea andb. Genotypesmustbe separated by a space. Missing values are denoted by"-".

If there is physical information for markers, i.e., if they are anchored atspecific positions in reference sequences (usually chromosomes), this isincluded immediately after the marker data. These lines start with specialkeywords*CHROM and*POS and containstrings andintegers, respectively, indicating the reference sequence andposition for each marker. These also need to be separated by spaces.

Finally, if there is phenotypic data, it will be added just after the markerorCHROM/POS data. They need to be separated by spaces aswell, using the same symbol for missing information.

Theexample directory in the package distribution contains anexample data file to be read with this function. Further instructions canbe found at the tutorial distributed along with this package.

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

error

matrix containing HMM emission probabilities

Author(s)

Gabriel R A Margarido,gramarga@gmail.com

References

Lincoln, S. E., Daly, M. J. and Lander, E. S. (1993)Constructing genetic linkage maps with MAPMAKER/EXP Version 3.0: a tutorialand reference manual.A Whitehead Institute for Biomedical ResearchTechnical Report.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

See Also

combine_onemap and theexampledirectory in the package source.

Examples

 outcr_data <- read_onemap(inputfile=  system.file("extdata/onemap_example_out.raw", package= "onemap"))

Recombination Counting and Ordering

Description

Implements the marker ordering algorithmRecombination Counting andOrdering (Van Os et al., 2005).

Usage

record(  input.seq,  times = 10,  LOD = 0,  max.rf = 0.5,  tol = 1e-04,  rm_unlinked = TRUE,  size = NULL,  overlap = NULL,  phase_cores = 1,  hmm = TRUE,  parallelization.type = "PSOCK",  verbose = TRUE)

Arguments

input.seq

an object of classsequence.

times

integer. Number of replicates of the RECORD procedure.

LOD

minimum LOD-Score threshold used when constructing the pairwiserecombination fraction matrix.

max.rf

maximum recombination fraction threshold used as the LODvalue above.

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and record is performed again.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

hmm

logical defining if the HMM must be applied to estimate multipointgenetic distances

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

verbose

A logical, if TRUE it output progress status information.

Details

Recombination Counting and Ordering (RECORD) is an algorithmfor marker ordering in linkage groups. It is not an exhaustive searchmethod and, therefore, is not computationally intensive. However, it doesnot guarantee that the best order is always found. The only requirement isa matrix with recombination fractions between markers.

After determining the order withRECORD, the final map isconstructed using the multipoint approach (functionmap).

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Marcelo Mollinari,mmollina@usp.br

References

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia,A. A. F. (2009) Evaluation of algorithms used to order markers on geneticsmaps.Heredity 103: 494-502.

Van Os, H., Stam, P., Visser, R.G.F. and Van Eck, H.J. (2005) RECORD: anovel method for ordering loci on a genetic linkage map.Theoreticaland Applied Genetics 112: 30-40.

See Also

make_seq andmap

Examples

  ##outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.rec <- record(LG1, hmm = FALSE)  ##F2 example  data(onemap_example_f2)  twopt <- rf_2pts(onemap_example_f2)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.rec <- record(LG1, hmm = FALSE)  LG1.rec

Remove individuals from the onemap object

Description

Remove individuals from the onemap object

Usage

remove_inds(onemap.obj = NULL, rm.ind = NULL, list.seqs = NULL)

Arguments

onemap.obj

object of class onemap

rm.ind

vector of characters with individuals names

list.seqs

list of objects of class sequence

Value

An object of classonemap without the selected individualsif onemap object is used as input, or a list of objects of classsequencewithout the selected individuals if a list of sequences objects is use as input

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Two-point analysis between genetic markers

Description

Performs the two-point (pairwise) analysis proposed byWu et al.(2002) between all pairs of markers.

Usage

rf_2pts(input.obj, LOD = 3, max.rf = 0.5, verbose = TRUE, rm_mks = FALSE)

Arguments

input.obj

an object of classonemap.

LOD

minimum LOD Score to declare linkage (defaults to3).

max.rf

maximum recombination fraction to declare linkage (defaultsto0.50).

verbose

logical. IfTRUE, current progress is shown; ifFALSE, no output is produced.

rm_mks

logical. IfTRUE the algorithm will remove the markers for which it found numerical problems to calculates the recombination fraction. The numerical problems can happens because of excess of missing data or segregation deviation.

Details

Forn markers, there are

\frac{n(n-1)}{2}

pairs ofmarkers to be analyzed. Therefore, completion of the two-point analyses cantake a long time.

Value

An object of classrf_2pts, which is a list containing thefollowing components:

n.mar

total number of markers.

LOD

minimum LOD Score to declarelinkage.

max.rf

maximum recombination fraction to declare linkage.

input

the name of the input file.

analysis

an array with thecomplete results of the two-point analysis for each pair of markers.

Note

The thresholds used forLOD andmax.rf will be used insubsequent analyses, but can be overriden.

Author(s)

Gabriel R A Margaridogramarga@gmail.com and Marcelo Mollinarimmollina@usp.br

References

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002)Simultaneous maximum likelihood estimation of linkage and linkage phases inoutcrossing species.Theoretical Population Biology 61: 349-363.

Examples

  data(onemap_example_out)  twopts <- rf_2pts(onemap_example_out,LOD=3,max.rf=0.5) # perform two-point analyses  twopts  print(twopts,c("M1","M2")) # detailed results for markers 1 and 2

Plots pairwise recombination fractions and LOD Scores in a heatmap

Description

Plots a matrix of pairwise recombination fraction orLOD Scores using a color scale. Any value of thematrix can be easily accessed using an interactive plotly-html interface,helping users to check for possible problems.

Usage

rf_graph_table(  input.seq,  graph.LOD = FALSE,  main = NULL,  inter = FALSE,  html.file = NULL,  mrk.axis = "numbers",  lab.xy = NULL,  n.colors = 4,  display = TRUE)

Arguments

input.seq

an object of classsequence with a predefinedorder.

graph.LOD

logical. IfTRUE, displays the LOD heatmap, otherwise,displays the recombination fraction heatmap.

main

character. The title of the plot.

inter

logical. IfTRUE, an interactive HTML graphic is plotted.Otherwise, a default graphic device is used.

html.file

character naming the html file with interative graphic.

mrk.axis

character, "names" to display marker names in the axis, "numbers" to displaymarker numbers and "none" to display axis free of labels.

lab.xy

character vector with length 2, first component is the label of x axis and second of the y axis.

n.colors

integer. Number of colors in the pallete.

display

logical. If interTRUE and displayTRUE interactive graphic is plotted in browser automatically when run the function

Details

The color scale varies from red (small distances or big LODs) to purple.When hover on a cell, a dialog box is displayed with some informationabout corresponding markers for that cell (line (y)\times column (x)). They are:i) the name of the markers;ii) the number ofthe markers on the data set;iii) the segregation types;iv)the recombination fraction between the markers andv) the LOD-Scorefor each possible linkage phase calculated via two-point analysis. Forneighbor markers, the multipoint recombination fraction is printed;otherwise, the two-point recombination fraction is printed. For markers oftypeD1 andD2, it is impossible to calculate recombinationfraction via two-point analysis and, therefore, the corresponding cell willbe empty (white color). For cells on the diagonal of the matrix, the name, the number andthe type of the marker are printed, as well as the percentage of missingdata for that marker.

Value

a ggplot graphic

Author(s)

Rodrigo Amadeu,rramadeu@gmail.com

Examples

##outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.rcd <- rcd(LG1)  rf_graph_table(LG1.rcd, inter=FALSE)  ##F2 example  data(onemap_example_f2)  twopt <- rf_2pts(onemap_example_f2)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  ##"pre-allocate" an empty list of length groups$n.groups (3, in this case)  maps.list<-vector("list", groups$n.groups)  for(i in 1:groups$n.groups){    ##create linkage group i    LG.cur <- make_seq(groups,i)    ##ordering    map.cur<-order_seq(LG.cur, subset.search = "sample")    ##assign the map of the i-th group to the maps.list    maps.list[[i]]<-make_seq(map.cur, "force")  }

Filter markers according with a two-points recombination fraction and LOD threshold. Adapted from MAPpoly.

Description

Filter markers according with a two-points recombination fraction and LOD threshold. Adapted from MAPpoly.

Usage

rf_snp_filter_onemap(  input.seq,  thresh.LOD.rf = 5,  thresh.rf = 0.15,  probs = c(0.05, 1))

Arguments

input.seq

an object of classonemap.

thresh.LOD.rf

LOD score threshold for recombination fraction (default = 5)

thresh.rf

threshold for recombination fractions (default = 0.15)

probs

indicates the probability corresponding to the filtering quantiles. (default = c(0.05, 1))

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

object of classonemap with the rawdata.

twopt

object of classrf_2pts with the2-point analyses.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

Examples

 data("vcf_example_out") twopts <- rf_2pts(vcf_example_out) seq1 <- make_seq(twopts, which(vcf_example_out$CHROM == "1"))filt_seq <- rf_snp_filter_onemap(seq1, 20, 0.5, c(0.5,1))

Compares and displays plausible alternative orders for a given linkagegroup

Description

For a given sequence of ordered markers, computes the multipoint likelihoodof alternative orders, by shuffling subsets (windows) of markers within thesequence. For each position of the window, all possible(ws)!orders are compared.

Usage

ripple_seq(input.seq, ws = 4, ext.w = NULL, LOD = 3, tol = 0.1, verbose = TRUE)

Arguments

input.seq

an object of classsequence with apredefined order.

ws

an integer specifying the length of the window size(defaults to 4).

ext.w

an integer specifying how many markers should beconsidered in the vicinity of the permuted window. Ifext.w=NULL all markers in the sequence areconsidered. In this version, it is used only in backcross,F_2 or RIL crosses.

LOD

threshold for the LOD-Score, so that alternative orderswith LOD less then or equal to this threshold will bedisplayed.

tol

tolerance for the C routine, i.e., the value used toevaluate convergence.

verbose

A logical, if TRUE it output progress statusinformation.

Details

Large values for the window size make computations very slow, specially ifthere are many partially informative markers.

Value

This function does not return any value; it just producestext output to suggest alternative orders.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com andMarcelo Mollinari,mmollina@usp.br

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Jiang, C. and Zeng, Z.-B. (1997). Mapping quantitative trait loci withdominant and missing markers in various crosses from two inbred lines.Genetica 101: 47-58.

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M. J., Lincoln,S. E. and Newburg, L. (1987) MAPMAKER: An interactive computer package forconstructing primary genetic linkage maps of experimental and naturalpopulations.Genomics 1: 174-181.

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia, A. A. F.(2009) Evaluation of algorithms used to order markers on genetics maps.Heredity 103: 494-502.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkage mapping ofsex-specific differences.Genetical Research 79: 85-96

See Also

make_seq,compare,try_seqandorder_seq.

Examples

#Outcross example data(onemap_example_out) twopt <- rf_2pts(onemap_example_out) markers <- make_seq(twopt,c(27,16,20,4,19,21,23,9,24,29)) markers.map <- map(markers) ripple_seq(markers.map)#F2 exampledata(onemap_example_f2)twopt <- rf_2pts(onemap_example_f2)all_mark <- make_seq(twopt,"all")groups <- group(all_mark)LG3 <- make_seq(groups,1)LG3.ord <- order_seq(LG3, subset.search = "twopt", twopt.alg = "rcd", touchdown=TRUE)LG3.ordmake_seq(LG3.ord) # get safe sequenceord.1<-make_seq(LG3.ord,"force") # get forced sequenceripple_seq(ord.1, ws=5)

Remove duplicated markers keeping the one with less missing data

Description

Remove duplicated markers keeping the one with less missing data

Usage

rm_dupli_mks(onemap.obj)

Arguments

onemap.obj

object of classonemap

Value

An empty object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Save a list of onemap sequence objects

Description

The onemap sequence object contains everything users need to reproduce the complete analysis:the input onemap object, the rf_2pts result, and the sequence genetic distance and marker order.Therefore, a list of sequences is the only object users need to save to be able to recover all analysis.But simple saving the list of sequences will save many redundant objects. This redundancy is only considered by Rwhen saving the object. For example, one input object and the rf_2pts result will be saved for every sequence.

Usage

save_onemap_sequences(sequences.list, filename)

Arguments

sequences.list

list ofsequence objects

filename

name of the output file (Ex: my_beautiful_map.RData)


Construct the linkage map for a sequence of markers after seeding phases

Description

Estimates the multipoint log-likelihood, linkage phases and recombinationfrequencies for a sequence of markers in a given order using seeded phases.

Usage

seeded_map(  input.seq,  tol = 1e-04,  phase_cores = 1,  seeds,  verbose = FALSE,  rm_unlinked = FALSE,  parallelization.type = "PSOCK")

Arguments

input.seq

an object of classsequence.

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

seeds

A vector given the integer encoding of phases for the firstN positions of the map

verbose

A logical, if TRUE it output progress statusinformation.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and map is performed again.

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

Details

Markers are mapped in the order defined in the objectinput.seq. Thebest combination of linkage phases is also estimated starting from the firstposition not in the given seeds.The multipoint likelihood is calculatedaccording to Wu et al. (2002b)(Eqs. 7a to 11), assuming that therecombination fraction is the same in both parents. Hidden Markov chaincodes adapted from Broman et al. (2008) were used.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classoutcross with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Adapted from Karl Broman (package 'qtl') by Gabriel R A Margarido,gramarga@usp.br and Marcelo Mollinari,mmollina@gmail.com.Modified to use seeded phases by Bastian Schiffthalerbastian.schiffthaler@umu.se

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Jiang, C. and Zeng, Z.-B. (1997). Mapping quantitative trait loci withdominant and missing markers in various crosses from two inbred lines.Genetica 101: 47-58.

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M. J., Lincoln,S. E. and Newburg, L. (1987) MAPMAKER: An interactive computer package forconstructing primary genetic linkage maps of experimental and naturalpopulations.Genomics 1: 174-181.

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a) Simultaneous maximumlikelihood estimation of linkage and linkage phases in outcrossing species.Theoretical Population Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkage mapping ofsex-specific differences.Genetical Research 79: 85-96

See Also

make_seq

Examples

  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  markers <- make_seq(twopt,c(30,12,3,14,2))  seeded_map(markers, seeds = c(4,2))

Show markers with/without segregation distortion

Description

A function to shows which marker have segregation distortion if Bonferroni's correction isapplied for the Chi-square tests of mendelian segregation.

Usage

select_segreg(x, distorted = FALSE, numbers = FALSE, threshold = NULL)

Arguments

x

an object of class onemap_segreg_test

distorted

a TRUE/FALSE variable to show distorted or non-distorted markers

numbers

a TRUE/FALSE variable to show the numbers or the names of the markers

threshold

a number between 0 and 1 to specify the threshold (alpha) to be considered in the test. If NULL, it uses the threshold alpha = 0.05. Bonferroni correction is applied for multiple test correction.

Value

a vector with marker names or numbers, according to the option for "distorted" and "numbers"

Examples

 # Loads a fake backcross dataset installed with onemap data(onemap_example_out) # Performs the chi-square test for all markers Chi <- test_segregation(onemap_example_out) # To show non-distorted markers select_segreg(Chi) # To show markers with segregation distortion select_segreg(Chi, distorted=TRUE) # To show the numbers of the markers with segregation distortion select_segreg(Chi, distorted=TRUE, numbers=TRUE)

Extract marker number by name

Description

Extract marker number by name

Usage

seq_by_type(sequence, mk_type)

Arguments

sequence

object of class or sequence

mk_type

vector of character with marker type to be selected

Value

New sequence object of classsequence with selected marker type, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

object of classonemap with the rawdata.

twopt

object of classrf_2pts with the2-point analyses.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

See Also

make_seq


Seriation

Description

Implements the marker ordering algorithmSeriation (Buetow &Chakravarti, 1987).

Usage

seriation(  input.seq,  LOD = 0,  max.rf = 0.5,  tol = 1e-04,  rm_unlinked = TRUE,  size = NULL,  overlap = NULL,  phase_cores = 1,  hmm = TRUE,  parallelization.type = "PSOCK",  verbose = TRUE)

Arguments

input.seq

an object of classsequence.

LOD

minimum LOD-Score threshold used when constructing the pairwiserecombination fraction matrix.

max.rf

maximum recombination fraction threshold used as the LODvalue above.

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and ug is performed again.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

hmm

logical defining if the HMM must be applied to estimate multipointgenetic distances

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

verbose

A logical, if TRUE it output progress statusinformation.

Details

Seriation is an algorithm for marker ordering in linkage groups. Itis not an exhaustive search method and, therefore, is not computationallyintensive. However, it does not guarantee that the best order is alwaysfound. The only requirement is a matrix with recombination fractionsbetween markers.

NOTE: When there are to many pairs of markers with the same value in therecombination fraction matrix, it can result in ties during the ordinationprocess and theSeriation algorithm may not work properly. This isparticularly relevant for outcrossing populations with mixture of markersof typeD1 andD2. When this occurs, the function shows thefollowing error message:There are too many ties in the ordinationprocess - please, consider using another ordering algorithm.

After determining the order withSeriation, the final map isconstructed using the multipoint approach (functionmap).

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.

Author(s)

Gabriel R A Margarido,gramarga@gmail.com

References

Buetow, K. H. and Chakravarti, A. (1987) Multipoint genemapping using seriation. I. General methods.American Journal ofHuman Genetics 41: 180-188.

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia, A. A. F.(2009) Evaluation of algorithms used to order markers on genetics maps.Heredity 103: 494-502.

See Also

make_seq,map

Examples

  ##outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG3 <- make_seq(groups,3)  LG3.ser <- seriation(LG3)

Defines the default mapping function

Description

Defines the function that should be used to display the genetic map throughthe analysis.

Usage

set_map_fun(type = c("kosambi", "haldane"))

Arguments

type

Indicates the function that should be used, which can be"kosambi" or"haldane"

Value

No return value, called for side effects

Kosambi, D. D. (1944) The estimation of map distance from recombinationvalues.Annuaire of Eugenetics 12: 172-175.

Author(s)

Marcelo Mollinari,mmollina@usp.br

References

Haldane, J. B. S. (1919) The combination of linkage values andthe calculation of distance between the loci of linked factors.Journal of Genetics 8: 299-309.

See Also

kosambi andhaldane


Simulated data from a backcross population

Description

Simulated data set from a backcross population.

Usage

data(simu_example_bc)

Format

The format is:List of 11$ geno : num [1:200, 1:54] 1 2 1 1 2 2 2 1 1 2 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:200] "BC_001" "BC_002" "BC_003" "BC_004" ..... ..$ : chr [1:54] "M001" "M002" "M003" "M004" ...$ n.ind : int 200$ n.mar : int 54$ segr.type : chr [1:54] "A.H" "A.H" "A.H" "A.H" ...$ segr.type.num: num [1:54] 8 8 8 8 8 8 8 8 8 8 ...$ n.phe : int 0$ pheno : NULL$ CHROM : NULL$ POS : NULL$ input : chr "simu_example_bc.raw"$ error : num [1:10800, 1:2] 1 1 1 1 1 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:10800] "M001_BC_001" "M002_BC_001" "M003_BC_001" "M004_BC_001" ..... ..$ : NULL- attr(*, "class")= chr [1:2] "onemap" "backcross"

Details

A simulation of a backcross population of 200 individuals genotyped with 54 markers. There are no missing data. There are two groups, one (Chr01) with a total of 100 cM and the other (Chr10) with 150 cM. The markers are positioned equidistant from each other.

Author(s)

Cristiane Taniguti,chtaniguti@usp.br

See Also

read_onemap andread_mapmaker.

Examples

data(simu_example_bc)# perform two-point analysestwopts <- rf_2pts(simu_example_bc)twopts

Simulated data from a f2 intercross population

Description

Simulated data set from a f2 intercross population.

Usage

data(simu_example_f2)

Format

The format is:List of 11$ geno : num [1:200, 1:54] 1 2 1 1 2 2 1 1 1 2 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:200] "F2_001" "F2_002" "F2_003" "F2_004" ..... ..$ : chr [1:54] "M001" "M002" "M003" "M004" ...$ n.ind : int 200$ n.mar : int 54$ segr.type : chr [1:54] "C.A" "C.A" "C.A" "C.A" ...$ segr.type.num: num [1:54] 7 7 7 7 4 4 7 4 4 4 ...$ n.phe : int 0$ pheno : NULL$ CHROM : NULL$ POS : NULL$ input : chr "simu_example_f2.raw"$ error : num [1:10800, 1:4] 1 1 1 1 1 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:10800] "M001_F2_001" "M002_F2_001" "M003_F2_001" "M004_F2_001" ..... ..$ : NULL- attr(*, "class")= chr [1:2] "onemap" "f2"

Details

A simulation of a f2 intercross population of 200 individuals genotyped with 54 markers. There are no missing data. There are two groups, one (Chr01) with a total of 100 cM and the other (Chr10) with 150 cM. The markers are positioned equidistant from each other.

Author(s)

Cristiane Taniguti,chtaniguti@usp.br

See Also

read_onemap andread_mapmaker.

Examples

data(simu_example_f2)# perform two-point analysestwopts <- rf_2pts(simu_example_f2)twopts

Simulated data from a outcrossing population

Description

Simulated data set from a outcrossing population.

Usage

data(simu_example_out)

Format

The format is:List of 11$ geno : num [1:200, 1:54] 2 1 2 1 1 2 2 2 1 1 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:200] "F1_001" "F1_002" "F1_003" "F1_004" ..... ..$ : chr [1:54] "M001" "M002" "M003" "M004" ...$ n.ind : int 200$ n.mar : int 54$ segr.type : chr [1:54] "D2.16" "D2.17" "D2.17" "D1.9" ...$ segr.type.num: num [1:54] 7 7 7 6 1 3 3 1 7 6 ...$ n.phe : int 0$ pheno : NULL$ CHROM : NULL$ POS : NULL$ input : chr "simu_example_out.raw"$ error : num [1:10800, 1:4] 1.00e-05 1.00e-05 1.00e-05 1.00 3.33e-06 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:10800] "M001_F1_001" "M002_F1_001" "M003_F1_001" "M004_F1_001" ..... ..$ : NULL- attr(*, "class")= chr [1:2] "onemap" "outcross"

Details

A simulation of a outcrossing population of 200 individuals genotyped with 54 markers. There are no missing data. There are two groups, one (Chr01) with a total of 100 cM and the other (Chr10) with 150 cM. The markers are positioned equidistant from each other.

Author(s)

Cristiane Taniguti,chtaniguti@usp.br

See Also

read_onemap andread_mapmaker.

Examples

data(simu_example_out)# perform two-point analysestwopts <- rf_2pts(simu_example_out)twopts

Sort markers in onemap object by their position in reference genome

Description

Sort markers in onemap object by their position in reference genome

Usage

sort_by_pos(onemap.obj)

Arguments

onemap.obj

object of class onemap

Value

An object of classonemap, i.e., a list with the followingcomponents:

geno

a matrix with integers indicating the genotypesread for each marker. Each column contains data for a marker and each rowrepresents an individual.

n.ind

number of individuals.

n.mar

number of markers.

segr.type

a vector with thesegregation type of each marker, asstrings.

segr.type.num

avector with the segregation type of each marker, represented in asimplified manner as integers, i.e. 1 corresponds to markers of type"A"; 2 corresponds to markers of type"B1.5"; 3 correspondsto markers of type"B2.6"; 4 corresponds to markers of type"B3.7"; 5 corresponds to markers of type"C.8"; 6 correspondsto markers of type"D1" and 7 corresponds to markers of type"D2". Markers for F2 intercrosses are coded as 1; all other crossesare left asNA.

input

the name of the input file.

n.phe

number of phenotypes.

pheno

a matrix with phenotypicvalues. Each column contains data for a trait and each row represents anindividual.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Split rf_2pts object by markers

Description

Split rf_2pts object by markers

Usage

split_2pts(twopts.obj, mks)

Arguments

twopts.obj

object of class rf_2pts

mks

markers names (vector of characters) or number (vector of integers) to be removed and added to a new rf_2pts object

Value

An object of classrf_2pts with only the selected markers, which is a list containing thefollowing components:

n.mar

total number of markers.

LOD

minimum LOD Score to declarelinkage.

max.rf

maximum recombination fraction to declare linkage.

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu


Split onemap data sets

Description

Receives one onemap object and a vector with markers names to be removed from the input onemap object and inserted in a new one. The outputis a list containing the two onemap objects.

Usage

split_onemap(onemap.obj = NULL, mks = NULL)

Arguments

onemap.obj

object of class onemap

mks

markers names (vector of characters) or number (vector of integers) to be removed and added to a new onemap object

Value

a list containing in first level the original onemap object without the indicated markers and the second level the new onemap object with only the indicated markers


Suggests a LOD Score for two point tests

Description

It suggests a LOD Score for declaring statistical significance for two-point testsfor linkage between all pairs of markers, considering that multiple tests are being performed.

Usage

suggest_lod(x)

Arguments

x

an object of classsequence oronemap

Details

In a somehow naive approach, the function calculates the number of two-point tests thatwill be performed for all markers in the data set, and then using this to calculatethe global alpha required to control type I error using Bonferroni's correction.

From this global alpha, the corresponding quantile from the chi-square distribution is takenand then converted to LOD Score.

This can be seen as just an initial approximation to help users to select a LOD Score for twopoint tests.

Value

the suggested LOD to be used for testing linkage

Examples

data(onemap_example_bc) # Loads a fake backcross dataset installed with onemapsuggest_lod(onemap_example_bc) # An value that should be used to start the analysis

Create table with summary information about the linkage map

Description

Create table with summary information about the linkage map

Usage

summary_maps_onemap(map.list, mapping_function = "kosambi")

Arguments

map.list

a map, i.e. an object of classsequence with apredefined order, linkage phases, recombination fraction and likelihood;also it could be a list of maps.

mapping_function

either "kosambi" or "haldane"

Value

data.frame with basic summary statistics

Author(s)

Jeekin Lau,jeekinlau@gmail.com


test_segregation

Description

Using OneMap internal function test_segregation_of_a_marker(),performs the Chi-square test to check if all markers in a dataset are followingthe expected segregation pattern, i. e., 1:1:1:1 (A), 1:2:1 (B), 3:1 (C) and 1:1 (D)according to OneMap's notation.

Usage

test_segregation(x, simulate.p.value = FALSE)

Arguments

x

an object of classonemap, with data and additional information.

simulate.p.value

a logical indicating whether to compute p-values by Monte Carlo simulation.

Details

First, it identifies the correct segregation pattern and corresponding H0 hypothesis,and then tests it.

Value

an object of class onemap_segreg_test, which is a list with marker name,H0 hypothesis being tested, the chi-square statistics, the associated p-valuesand the % of individuals genotyped. To see the object, it is necessary to printit.

Examples

 data(onemap_example_out) # Loads a fake outcross dataset installed with onemap Chi <- test_segregation(onemap_example_out) # Performs the chi-square test for all markers print(Chi) # Shows the results

test_segregation_of_a_marker

Description

Applies the chi-square test to check if markers are following theexpected segregation pattern, i. e., 1:1:1:1 (A), 1:2:1 (B), 3:1 (C) and 1:1 (D)according to OneMap's notation. It does not use Yate's correction.

Usage

test_segregation_of_a_marker(x, marker, simulate.p.value = FALSE)

Arguments

x

an object of classonemap, with data and additional information.

marker

the marker which will be tested for its segregation.

simulate.p.value

a logical indicating whether to compute p-values by Monte Carlo simulation.

Details

First, the function selects the correct segregation pattern, then itdefines the H0 hypothesis, and then tests it, together with percentage ofmissing data.

Value

a list with the H0 hypothesis being tested, the chi-square statistics,the associated p-values, and the % of individuals genotyped.

Examples

data(onemap_example_bc) # Loads a fake backcross dataset installed with onemaptest_segregation_of_a_marker(onemap_example_bc,1)data(onemap_example_out) # Loads a fake outcross dataset installed with onemaptest_segregation_of_a_marker(onemap_example_out,1)

Try to map a marker into every possible position between markersin a given map

Description

For a given linkage map, tries do add an additional unpositionedmarker. This function estimates parameters for all possible mapsincluding the new marker in all possible positions, while keepingthe original linkage map unaltered.

Usage

try_seq(input.seq, mrk, tol = 0.1, pos = NULL, verbose = FALSE)

Arguments

input.seq

an object of classsequence with apredefined order.

mrk

the index of the marker to be tried, according to theinput file.

tol

tolerance for the C routine, i.e., the value used toevaluate convergence.

pos

defines in which position the new markermrkshould be placed for the diagnostic graphic. IfNULL(default), the marker is placed on the best position i.e. theone which results LOD = 0.00

verbose

ifFALSE (default), simplified output isdisplayed. ifTRUE, detailed output is displayed.

Value

An object of classtry, which is a list containingthe following components:

ord

alist containingresults for every linkage map estimated. These resultsinclude linkage phases, recombination frequencies andlog-likelihoods.

LOD

avector with LOD-Scoresfor each position where the additional marker is placed. ThisScore is based on the best combination of linkage phases foreach map.

try.ord

amatrix with the orders ofall linkage maps.

data.name

name of the object ofclassonemap with the raw data.

twopt

name ofthe object of classrf_2pts with the 2-point analyses.

Author(s)

Marcelo Mollinari,mmollina@usp.br

References

Broman, K. W., Wu, H., Churchill, G., Sen, S.,Yandell, B. (2008)qtl: Tools for analyzing QTLexperiments R package version 1.09-43

Jiang, C. and Zeng, Z.-B. (1997). Mapping quantitative trait lociwith dominant and missing markers in various crosses from twoinbred lines.Genetica 101: 47-58.

Lander, E. S., Green, P., Abrahamson, J., Barlow, A., Daly, M. J.,Lincoln, S. E. and Newburg, L. (1987) MAPMAKER: An interactivecomputer package for constructing primary genetic linkage mapsof experimental and natural populations.Genomics 1:174-181.

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia,A. A. F. (2009) Evaluation of algorithms used to ordermarkers on genetic maps.Heredity 103: 494-502

Wu, R., Ma, C.-X., Painter, I. and Zeng, Z.-B. (2002a)Simultaneous maximum likelihood estimation of linkage andlinkage phases in outcrossing species.TheoreticalPopulation Biology 61: 349-363.

Wu, R., Ma, C.-X., Wu, S. S. and Zeng, Z.-B. (2002b). Linkagemapping of sex-specific differences.Genetical Research79: 85-96

See Also

make_seq andcompare.

Examples

  #outcrossing example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  markers <- make_seq(twopt,c(2,3,12,14))  markers.comp <- compare(markers)  base.map <- make_seq(markers.comp,1)  extend.map <- try_seq(base.map,30)  extend.map  print(extend.map,5) # best position  print(extend.map,4) # second best position

Run try_seq considering previous sequence

Description

It uses try_seq function repeatedly trying to positioned each marker in a vector of markers into a already ordered sequence.Each marker in the vector"markers" is kept in the sequence if the difference of LOD and total group size of the models with and without the marker are below the thresholds"lod.thr" and"cM.thr".

Usage

try_seq_by_seq(sequence, markers, cM.thr = 10, lod.thr = -10, verbose = TRUE)

Arguments

sequence

object of class sequence with ordered markers

markers

vector of integers defining the marker numbers to be inserted in thesequence

cM.thr

number defining the threshold for total map size increase when inserting a single marker

lod.thr

the difference of LODs between model before and after inserting the marker need to have value higher than the value defined in this argument

verbose

A logical, if TRUE it output progress statusinformation.

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

name of the object of classonemap with the rawdata.

twopt

name of the object of classrf_2pts with the2-point analyses.


Unidirectional Growth

Description

Implements the marker ordering algorithmUnidirectional Growth(Tan & Fu, 2006).

Usage

ug(  input.seq,  LOD = 0,  max.rf = 0.5,  tol = 1e-04,  rm_unlinked = TRUE,  size = NULL,  overlap = NULL,  phase_cores = 1,  hmm = TRUE,  parallelization.type = "PSOCK",  verbose = TRUE)

Arguments

input.seq

an object of classsequence.

LOD

minimum LOD-Score threshold used when constructing the pairwiserecombination fraction matrix.

max.rf

maximum recombination fraction threshold used as the LODvalue above.

tol

tolerance for the C routine, i.e., the value used to evaluateconvergence.

rm_unlinked

When some pair of markers do not follow the linkage criteria, ifTRUE one of the markers is removed and ug is performed again.

size

The center size around which an optimum is to be searched

overlap

The desired overlap between batches

phase_cores

The number of parallel processes to use when estimatingthe phase of a marker. (Should be no more than 4)

hmm

logical defining if the HMM must be applied to estimate multipointgenetic distances

parallelization.type

one of the supported cluster types. This should be either PSOCK (default) or FORK.

verbose

A logical, if TRUE it output progress statusinformation.

Details

Unidirectional Growth (UG) is an algorithm for markerordering in linkage groups. It is not an exhaustive search method and,therefore, is not computationally intensive. However, it does not guaranteethat the best order is always found. The only requirement is a matrix withrecombination fractions between markers.

After determining the order withUG, the final map is constructedusing the multipoint approach (functionmap).

Value

An object of classsequence, which is a list containing thefollowing components:

seq.num

avector containing the(ordered) indices of markers in the sequence, according to the input file.

seq.phases

avector with the linkage phases between markersin the sequence, in corresponding positions.-1 means that there areno defined linkage phases.

seq.rf

avector with therecombination frequencies between markers in the sequence.-1 meansthat there are no estimated recombination frequencies.

seq.like

log-likelihood of the corresponding linkage map.

data.name

object of classonemap with the rawdata.

twopt

object of classrf_2pts with the2-point analyses.

Author(s)

Marcelo Mollinari,mmollina@usp.br

References

Mollinari, M., Margarido, G. R. A., Vencovsky, R. and Garcia,A. A. F. (2009) Evaluation of algorithms used to order markers on geneticsmaps.Heredity 103: 494-502.

Tan, Y. and Fu, Y. (2006) A novel method for estimating linkage maps.Genetics 173: 2383-2390.

See Also

make_seq,map

Examples

  #outcross example  data(onemap_example_out)  twopt <- rf_2pts(onemap_example_out)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.ug <- ug(LG1)  #F2 example  data(mapmaker_example_f2)  twopt <- rf_2pts(mapmaker_example_f2)  all_mark <- make_seq(twopt,"all")  groups <- group(all_mark)  LG1 <- make_seq(groups,1)  LG1.ug <- ug(LG1)  LG1.ug

These functions are defunct and no longer available.

Description

These functions are defunct and no longer available.

Usage

vcf2raw()

Value

No return value, called for side effects


Data generated from VCF file with biallelic markers from a f2 backcross population

Description

Simulated biallelic data set for an backcross population

Usage

data("vcf_example_bc")

Format

An object of classonemap.

Details

A total of 142 backcross individuals were genotyped with 25 markers. The datawas generated from a VCF file. It contains chromossome and positioninformations for each marker. It is included to be used as a example inorder to understand how to convert VCF file to OneMap input data with the functionsvcf2raw andonemap_read_vcfR.

Author(s)

Cristiane Hayumi Taniguti,chaytaniguti@gmail.com

See Also

read_onemap for details about objects of classonemap.

Examples

data(vcf_example_bc)plot(vcf_example_bc)

Data generated from VCF file with biallelic markers from a f2 intercross population

Description

Simulated biallelic data set for an f2 population

Usage

data(vcf_example_f2)

Format

An object of classonemap.

Details

A total of 192 F2 individuals were genotyped with 25 markers. The datawas generated from a VCF file. It contains chromossome and positioninformations for each marker. It is included to be used as a reference inorder to understand how to convert VCF file to OneMap input data. Also,it is used for the analysis in the tutorial that comes with OneMap.

Author(s)

Cristiane Hayumi Taniguti,chaytaniguti@gmail.com

See Also

read_onemap for details about objects of classonemap.

Examples

data(vcf_example_f2)# plot markers informationsplot(vcf_example_f2)

Data generated from VCF file with biallelic markers from a full-sib family derived from two outbred parents

Description

Simulated biallelic data set for an outcross, i.e., an F1 population obtained bycrossing two non-homozygous parents.

Usage

data(vcf_example_out)

Format

An object of classonemap.

Details

A total of 92 F1 individuals were genotyped with 27 markers. The datawas generated from a VCF file. It contains chromossome and positioninformations for each marker. It is included to be used as a reference inorder to understand how to convert VCF file to OneMap input data. Also,it is used for the analysis in the tutorial that comes with OneMap.

Author(s)

Cristiane Hayumi Taniguti,chaytaniguti@gmail.com

See Also

read_onemap for details about objects of classonemap.

Examples

data(vcf_example_out)# plot markers informationsplot(vcf_example_out)

Data generated from VCF file with biallelic markers from a RIL population produced by selfing

Description

Simulated biallelic data set for anri self population.

Usage

data("vcf_example_riself")

Format

The format is:List of 10$ geno : num [1:92, 1:25] 3 3 1 3 1 3 3 1 3 1 .....- attr(*, "dimnames")=List of 2.. ..$ : chr [1:92] "ID1" "ID3" "ID4" "ID5" ..... ..$ : chr [1:25] "SNP16" "SNP12" "SNP17" "SNP10" ...$ n.ind : int 92$ n.mar : int 25$ segr.type : chr [1:25] "A.B" "A.B" "A.B" "A.B" ...$ segr.type.num: logi [1:25] NA NA NA NA NA NA ...$ n.phe : int 0$ pheno : NULL$ CHROM : chr [1:25] "1" "1" "1" "1" ...$ POS : int [1:25] 1791 6606 9001 11326 11702 15533 17151 18637 19146 19220 ...$ input : chr "vcf_example_riself.raw"- attr(*, "class")= chr [1:2] "onemap" "riself"

Details

A total of 92 rils individuals were genotyped with 25 markers. The datawas generated from a VCF file. It contains chromossome and positioninformations for each marker. It is included to be used as a example inorder to understand how to convert VCF file to OneMap input data with the functionsvcf2raw andonemap_read_vcfR.

Author(s)

Cristiane Hayumi Taniguti,chaytaniguti@gmail.com

See Also

read_onemap for details about objects of classonemap.

Examples

data(vcf_example_riself)plot(vcf_example_riself)

Write a genetic map to a file

Description

Write a genetic map to a file, base on a given map, or a list of maps. Theoutput file can be used as an input to perform QTL mapping using the packageR/qtl. It is also possible to create an output to be used withQTLCartographer program.

Usage

write_map(map.list, file.out)

Arguments

map.list

a map, i.e. an object of classsequence with apredefined order, linkage phases, recombination fraction and likelihood ora list of maps.

file.out

output map file.

Details

This function is available only for backcross, F2 and RILs.

Value

file with genetic map information

Wang S., Basten, C. J. and Zeng Z.-B. (2010) Windows QTL Cartographer 2.5.Department of Statistics, North Carolina State University, Raleigh, NC.

Author(s)

Marcelo Mollinari,mmollina@usp.br

References

Broman, K. W., Wu, H., Churchill, G., Sen, S., Yandell, B.(2008)qtl: Tools for analyzing QTL experiments R package version1.09-43

Examples

data(mapmaker_example_f2)twopt<-rf_2pts(mapmaker_example_f2)lg<-group(make_seq(twopt, "all"))##"pre-allocate" an empty list of length lg$n.groups (3, in this case)maps.list<-vector("list", lg$n.groups)for(i in 1:lg$n.groups){  ##create linkage group i  LG.cur <- make_seq(lg,i)  ##ordering  map.cur<-order_seq(LG.cur, subset.search = "sample")  ##assign the map of the i-th group to the maps.list  maps.list[[i]]<-make_seq(map.cur, "force")  ##write maps.list to ".map" file  write_map(maps.list, tempfile(fileext = ".map"))}

Convert onemap object to onemap raw file

Description

Converts onemap R object to onemap input file. The input file brings information about the mapping population:First line: cross type, it can be "outcrossing", "f2 intercross", "f2 backcross", "ri self" or "ri sib".Second line: number of individuals, number of markers, presence (1) or absence (0) of chromossome and position of the markers, and number of phenotypes mesured.Third line: Individuals/sample names; Followed lines: marker name, marker type and genotypes. One line for each marker.Final lines: chromossome, position and phenotypes informations. See more about input file format at vignettes.

Usage

write_onemap_raw(onemap.obj = NULL, file.name = NULL)

Arguments

onemap.obj

object of class 'onemap'

file.name

a character for the onemap raw file name. Default is "out.raw"

Value

a onemap input file

Author(s)

Cristiane Taniguti,chtaniguti@tamu.edu

See Also

read_onemap for a description of the output object of class onemap.

Examples

data(onemap_example_out)write_onemap_raw(onemap_example_out, file.name = paste0(tempfile(), ".raw"))

[8]ページ先頭

©2009-2025 Movatter.jp