| Type: | Package | 
| Title: | Behavioral Change Point Analysis of Animal Movement | 
| Version: | 1.3.2 | 
| Date: | 2022-05-24 | 
| Author: | Eliezer Gurarie <egurarie@esf.edu> | 
| Maintainer: | Eliezer Gurarie <egurarie@esf.edu> | 
| Description: | The Behavioral Change Point Analysis (BCPA) is a method of identifying hidden shifts in the underlying parameters of a time series, developed specifically to be applied to animal movement data which is irregularly sampled. The method is based on: E. Gurarie, R. Andrews and K. Laidre A novel method for identifying behavioural changes in animal movement data (2009) Ecology Letters 12:5 395-408. A development version is on https://github.com/EliGurarie/bcpa. NOTE: the BCPA method may be useful for any univariate, irregularly sampled Gaussian time-series, but animal movement analysts are encouraged to apply correlated velocity change point analysis as implemented in the smoove package, as of this writing on GitHub at https://github.com/EliGurarie/smoove. An example of a univariate analysis is provided in the UnivariateBCPA vignette. | 
| License: | Unlimited | 
| Depends: | plyr | 
| Imports: | stats, Rcpp (≥ 0.11.0) | 
| Suggests: | knitr, lubridate, magrittr, circular, digest, rmarkdown | 
| VignetteBuilder: | knitr | 
| RoxygenNote: | 7.2.0 | 
| LinkingTo: | Rcpp | 
| NeedsCompilation: | yes | 
| Packaged: | 2022-05-27 15:30:10 UTC; elie | 
| Repository: | CRAN | 
| Date/Publication: | 2022-05-30 12:30:09 UTC | 
Behavioral Change Point Analysis
Description
A collection of functions that allows one to perform the behavioral change point analysis (BCPA) as described by Gurarie et al. (2009, Ecology Letters, 12: 395-408). The key features are estimation of discrete changes in time-series data, notable linear and turning components of gappy velocity times series extracted from movement data.
Details
For more movement-appropriate change point analysis, users are
encouraged to apply correlated velocity change point analysis as implemented
in the smoove package (as of this writing on GitHub at
https://github.com/EliGurarie/smoove)
which implements methods described in Gurarie et al. 2017.
There is a fairly detailed vignette - type in vignette("bcpa"), and an
updated vignette vignette("UnivariateBCPA") with a univariate example.
The key analysis function is WindowSweep, and
reading its documentation is a good way to start using this package.
WindowSweep uses a suite of functions that might be
useful for more narrow analysis. These functions are all available and
documented, and are listed here hierarchically, from the most fundamental
to the most complex:
-  GetRhomaximizes the likelihood to estimate autocorrelation rho or characteristic time-scale tau.
-  GetDoubleLestimates the parameters and returns the log-likelihood at either side of a given break
-  GetBestBreakfinds the single best change point according to the likelihood returned byGetDoubleL'](GetDoubleL)
-  GetModelsuses a (modified) BIC model selection for all combinations from M0 (\mu_1 = \mu_2,\sigma_1 = \sigma_2,\rho_1 = \rho_2) to M7 (\mu_1 \neq \mu_2,\sigma_1 \neq \sigma_2,\rho_1 \neq \rho_2) to characterize the "Best Break"
- Finally, - WindowSweepsweeps a longer time series with the Best Break / Model Selection analysis, identifying most likely break points and BIC selected models across the time series.
Summary, diagnostic, and plotting functions are:
-  PartitionParameters- estimated parameters of a BCPA.
-  ChangePointSummary- summary table of the change points.
-  plot.bcpa- a plotting method for visualizing the time series with vertical lines as change points.
-  PathPlot- a method for drawing a color-coded track of the analysis.
-  DiagPlot- diagnostic plots for BCPA.
A few preprocessing functions are also available:
-  plot.track- method for plotting a generic "track" object.
-  GetVT- returns step-lengths, absolute and turning angles from track data.
Author(s)
Eliezer Gurarie
References
- Gurarie, E., R. Andrews and K. Laidre. 2009. A novel method for identifying behavioural changes in animal movement data. Ecology Letters. 12: 395-408. 
- Gurarie, E., C. Fleming, W.F. Fagan, K. Laidre, J. Hernandez-Pliego, O. Ovaskainen. 2017. Correlated velocity models as a fundamental unit of animal movement: synthesis and applications. Movement Ecology, 5:13. 
Examples
# Running through a complete analysis:
## loading data
  data(Simp)
## plotting the track (using the plot.track method)
  plot(Simp)
## Obtaining the movement summary table (with turning angles and step lengths)
  Simp.VT <- GetVT(Simp)
## Applying the analysis
 if(interactive()){
  Simp.ws <- WindowSweep(Simp.VT, "V*cos(Theta)", windowsize = 50, 
                         windowstep = 1, progress=TRUE)
                         } else
 Simp.ws <- WindowSweep(Simp.VT, "V*cos(Theta)", windowsize = 50, 
                         windowstep = 1, progress=FALSE)
                                            
## plotting outpots
  plot(Simp.ws, threshold=7)
  plot(Simp.ws, type="flat", clusterwidth=3)
  PathPlot(Simp, Simp.ws)
  PathPlot(Simp, Simp.ws, type="flat")
## Diagnostic of assumptions
  DiagPlot(Simp.ws)
Obtain summary of BCPA analysis
Description
Produces a summary of change points for a "flat" analysis, identifying phases (periods between change points) with estimated parameters, clustering neighboring ones according to a kernel density of the windowsweep breaks.
Usage
ChangePointSummary(windowsweep, clusterwidth = 1, tau = TRUE)
Arguments
| windowsweep | a  | 
| clusterwidth | the temporal range within which change points are considered to be within the same cluster. Corresponds to the bandwidth of the density of the break distribution. | 
| tau | logical, whether to estimate the characteristic time tau (preferred) or not. If FALSE, the autocorrelation parameter rho is calculated. | 
Value
a list containing two elements:
| breaks | a data frame containing columns:   | 
| phases | a data frame containing columns  | 
Author(s)
Eliezer Gurarie
See Also
Examples
if(!exists("Simp.VT")){
 data(Simp)
 Simp.VT <- GetVT(Simp)}
if(!exists("Simp.ws"))
 Simp.ws <- WindowSweep(Simp.VT, "V*cos(Theta)", windowsize = 50, windowstep = 1, progress=TRUE)
# too many change points:
ChangePointSummary(Simp.ws)
# about the right number of change points:
ChangePointSummary(Simp.ws, clusterwidth=3)
Diagnostic plot for BCPA
Description
Draws diagnostic plots for BCPA analysis. Specifically: a qqplot, a histogram (with a N(0,1) density curve), and an acf of the standardized residuals of an analysis.
Usage
DiagPlot(
  windowsweep,
  type = c("smooth", "flat")[1],
  plotme = TRUE,
  values = FALSE,
  ...
)
Arguments
| windowsweep | a  | 
| type | whether to diagnose the model fitted for a smooth or flat BCPA. | 
| plotme | logical - whether or not to plot the diagnostics | 
| values | logical - whether or not to return the values of the standardized residuals. | 
| ... | additional arguments to pass to the  | 
Value
If values is TRUE, returns the values of the standardized residuals.
Author(s)
Eliezer Gurarie
See Also
Examples
data(Simp)
if(!exists("Simp.VT"))
 Simp.VT <- GetVT(Simp)
if(!exists("Simp.ws"))
 Simp.ws <- WindowSweep(Simp.VT, "V*cos(Theta)", windowsize = 50, windowstep = 1, progress=TRUE)
DiagPlot(Simp.ws)
DiagPlot(Simp.ws, type="flat")
# The Simp's diagnostic plots are excellent.
Find most likely change point in irregular time series
Description
Finds the single best change point according to the likelihood function.  Used internally within WindowSweep.
Usage
GetBestBreak(x, t, range = 0.6, ...)
Arguments
| x | vector of time series values. | 
| t | vector of times of measurements associated with x. | 
| range | of possible breaks. Default (0.6) runs approximately from 1/5 to 4/5 of the total length of the time series. | 
| ... | additional parameters to pass to  | 
Value
returns a single row (vector) with elements: breaks,tbreaks,mu1,sigma1,rho1,LL1,mu2,sigma2,rho2,LL2,LL. The breakpoint is calculated for a range of possible values of width range*l (where l is the length of the time series). The output of this function feeds WindowSweep.
Author(s)
Eliezer Gurarie
See Also
WindowSweep which uses it, and GetDoubleL for the likelihood estimation.
Examples
# An example with a single break:
x <- c(arima.sim(list(ar = 0.9), 20) + 10, arima.sim(list(ar = 0.1), 20)) 
t <- 1:length(x)
plot(t,x, type="l")
(bb <- GetBestBreak(x,t, tau=FALSE))
abline(v = bb[2], col=2)
Obtain log-likelihood and parameter estimates for a given break point.
Description
Takes a time series with values x obtained at time t and a time break tbreak, and returns the estimates of \mu, \sigma and \tau (or \rho) as well as the negative log-likelihood of those estimates before and after the break. Mostly for use internally within GetBestBreak.
Usage
GetDoubleL(x, t, tbreak, ...)
Arguments
| x | vector of time series values. | 
| t | vector of times of measurements associated with x. | 
| tbreak | breakpoint to test (in terms of the INDEX within "t" and "x", not actual time value). | 
| ... | additional parameters to pass to  | 
Value
a vector containing the parameters and the negative log-likelihoods in order: mu1, sigma1, tau1, LL1, mu2, sigma2, tau2, LL2
Author(s)
Eliezer Gurarie
See Also
GetBestBreak uses this function, while this function uses GetRho
Obtain likelihood estimates of gappy Gaussian time series
Description
Obtain likelihood of gappy standardized Gaussian time series "x" sampled at times "t" given parameter "rho" (autocorrelation). Alternatively computes the characteristic time scale "tau".
Arguments
| x | Time series | 
| t | Sampling times | 
| rho | Auto-correlation | 
| tau | logical: Whether or not to compute characteristic time scale instead of rho. | 
Value
Returns the log-likelihood of the data.
Author(s)
Eliezer Gurarie
See Also
Core function of BCPA, used directly in GetRho
Examples
# simulate autocorrelated time series
  rho.true <- 0.8
  x.full <- arima.sim(1000, model=list(ar = rho.true))
  t.full <- 1:1000
  
# subsample time series
  keep <- sort(sample(1:1000, 200))
  x <- x.full[keep]
  t <- t.full[keep]
  plot(t,x, type="l")
  
# Obtain MLE of rho
  rhos <- seq(0,.99,.01)
  L <- sapply(rhos, function(r) GetL(x, t, r))
  rho.hat <- rhos[which.max(L)]
  plot(rhos, L, type = "l")
  abline(v = c(rho.true, rho.hat), lty=3:2, lwd=2)
  legend("bottomleft", legend=c("true value","MLE"), lty=3:2, lwd=2, 
         title = expression(rho))
         
# Why tau is better
  tau.true <- -1/log(rho.true)
  taus <- seq(1,10,.1)
  L <- sapply(taus, function(r) GetL(x, t, r, tau = TRUE))
  tau.hat <- taus[which.max(L)]
  plot(taus, L, type = "l")
  abline(v = c(tau.true, tau.hat), lty=3:2, lwd=2)
  legend("bottomleft", legend=c("true value","MLE"), lty=3:2, lwd=2, 
         title = expression(tau))
Model selection at a known breakpoint
Description
Returns all parameter estimates and log-likelihoods for all possible models at a selected breakpoint. These are:
- M0 - all parameters equal 
- M1 - - \mu_1 != \mu_2
- M2 - - \sigma_1 != \sigma_2
- M3 - - \tau_1 != \tau_2
- M4 - - \mu_1 != \mu_2AND- \sigma_1 != \sigma_2
- M5 - - \mu_1 != \mu_2AND- \tau_1 != \tau_2
- M6 - - \sigma_1 != \sigma_2AND- \tau_1 != \tau_2
- M7 - all parameters unequal 
Usage
GetModels(x, t, breakpoint, K = 2, tau = TRUE)
Arguments
| x | vector of time series values. | 
| t | vector of times of measurements associated with x. | 
| breakpoint | breakpoint to test (in terms of the INDEX within "t" and "x", not actual time value). | 
| K | sensitivity parameter. Standard definition of BIC, K = 2. Smaller values of K mean less sensitive selection, i.e. higher likelihood of selecting null (or simpler) models. | 
| tau | whether or not to estimate time scale  | 
Value
Returns a names matrix with 8 rows (one for each model) and columns: Model, LL, bic, mu1, s1, rho1, mu2, s2, rho2.  Fairly self-explanatory.  Note that the rho columns include the tau values, if tau is TRUE (as it usually should be).
Author(s)
Eliezer Gurarie
See Also
Used directly within WindowSweep.  Relies heavily on GetRho.
Characteristic time / auto-correlation for irregular time series
Description
Estimates characteristic time \tau or auto-correlation \rho from 
a gappy time series dataset.  It works first by estimating the mean and 
standard deviation directly from the time series X, using these to 
standardize the time series, and then optimizes for the likelihood of the 
value of \tau or \rho.
Usage
GetRho(x, t, tau = TRUE)
Arguments
| x | vector of time series values. | 
| t | vector of times of measurements associated with x. | 
| tau | whether or not to estimate time scale  | 
Value
Returns a vector of length two: the estimate and the negative log-likelihood
Author(s)
Eliezer Gurarie
Obtain VT table from Track
Description
The VT table computes speeds, step lengths, orientations, turning angles and 
ancillary variables from a track. The output of this function is (typically) 
meant to feed the WindowSweep function.
Usage
GetVT(Data, units = "hour", skiplast = TRUE)
Arguments
| Data | a track to analyze.  Must contain columns: X, Y and Time (as a 
POSIX object).  The  | 
| units | the time units for the analysis; one of  | 
| skiplast | filters away last step. | 
Value
a data frame with the following columns:
| Z.start,Z.end | the start and end locations (as complex coordinates) | 
| S | the step length | 
| Phi,Theta | absolute and turning angle, respectively | 
| T.start,T.end | start and time of steps (numeric - in given units) | 
| T.mid | temporal midpoint of the step | 
| dT | duration of the step | 
| V | approximate speed (S/dT) | 
| T.POSIX | the temporal midpoint of the step as a POSIX objects. | 
Author(s)
Eliezer Gurarie
See Also
Examples
data(Simp)
plot(Simp)
Simp.VT <- GetVT(Simp)
head(Simp.VT)
# Distribution of estimated speeds
hist(Simp.VT$V, col="grey", breaks=20)
# Distribution of turning angles
if (requireNamespace("circular", quietly = TRUE)) 
   circular::rose.diag(Simp.VT$Theta, bins=24) else
     hist(Simp.VT$Theta)
Make Track
Description
Simple convenience function for creating a track class object from X-Y-Time movement data. A track class object can be conveniently plotted and analyzed within bcpa.
Usage
MakeTrack(X, Y, Time)
Arguments
| X | vector of X locations | 
| Y | vector of Y locations | 
| Time | vector of time (can be POSIX) | 
Value
a track class data frame, with three columns: X, Y and Time.
See Also
plot.track
Examples
X <- cumsum(arima.sim(n=100, model=list(ar=0.8)))
Y <- cumsum(arima.sim(n=100, model=list(ar=0.8)))
Time <- 1:100
mytrack <- MakeTrack(X,Y,Time)
plot(mytrack)
Partition parameters
Description
Partitions - and, ultimately, estimates - all parameters of a BCPA, either as a rolling average (smooth BCPA), or as constant values within fixed change points (flat BCPA).
Usage
PartitionParameters(
  windowsweep,
  type = c("smooth", "flat")[1],
  clusterwidth = 1
)
Arguments
| windowsweep | a  | 
| type | type of estimate to output, whether "smooth" or "flat". | 
| clusterwidth | the temporal range within which changepoints are considered to be within the same cluster (for a "smooth" BCPA). | 
Value
a data frame containing the three estimates: mu.hat, 
s.hat, rho.hat.
Author(s)
Eliezer Gurarie
See Also
used in ChangePointSummary and 
PhasePlot
Path plot of BCPA output
Description
Plots the animal's trajectory, with segments color-coded according to the time scale / auto-correlation of the BCPA output, and width of segments proportional to the estimated mean of the BCPA.
Usage
PathPlot(
  Data,
  windowsweep,
  type = c("smooth", "flat")[1],
  clusterwidth = 1,
  plotlegend = FALSE,
  tauwhere = "topleft",
  n.legend = 5,
  ncol.legend = 1,
  bty.legend = "n",
  ...
)
Arguments
| Data | the track data to be plotted - most typically, output of the 
 | 
| windowsweep | 
 | 
| type | whether to plot smooth or flat bcpa output | 
| clusterwidth | for flat BCPA, this is the temporal range within which change points are considered to be within the same cluster. | 
| plotlegend | whether to plot a legend. | 
| tauwhere | where to place the legend for the time-scale / auto-correlation. Can be one of "nowhere", "top", "bottom", "left", "right", "topleft", "topright", "bottomright", "bottomleft". | 
| n.legend | number of labels in legend. | 
| ncol.legend | number of columns in the legend. | 
| bty.legend | whether to draw a box around the legend. | 
| ... | additional arguments to pass to the  | 
Author(s)
Eliezer Gurarie
Examples
if(!exists("Simp.ws"))
{
 data(Simp)
 Simp.ws <- WindowSweep(GetVT(Simp), "V*cos(Theta)", windowsize = 50, 
 windowstep = 1, progress=TRUE)
}
PathPlot(Simp, Simp.ws, plotlegend=TRUE, n.legend=3)
PathPlot(Simp, Simp.ws, type="flat", clusterwidth=3, plotlegend=TRUE)
Phase plot of BCPA output
Description
Behavioral phase plot of BCPA output. Mean and standard deviation are on the x and y axis. Size and color of points represent the time scale of autocorrelation
Usage
PhasePlot(
  windowsweep,
  type = c("smooth", "flat")[1],
  clusterwidth = 1,
  ...,
  legend.where = "bottomright"
)
Arguments
| windowsweep | 
 | 
| type | whether to plot smooth or flat bcpa output | 
| clusterwidth | for flat BCPA, this is the temporal range within which change points are considered to be within the same cluster. | 
| ... | additional arguments passed to the  | 
| legend.where | where to place the tau legend (see  | 
Author(s)
Eliezer Gurarie
See Also
WindowSweep, PartitionParameters
Examples
if(!exists("Simp.ws"))
{
 data(Simp)
 Simp.ws <- WindowSweep(GetVT(Simp), "V*cos(Theta)", windowsize = 50, windowstep = 1, progress=TRUE)
}
PhasePlot(Simp.ws)
Simulated Chim (Simp) Data
Description
This is a simulated movement track from a continuous auto-correlated process of total duration 60 time units with four behavioral phases that switch at times T=10, 20 and 50 from, variously, higher or lower velocity and longer or shorter characteristic time scale of autocorrelation. The original data was simulated with time intervals of 0.01 (leading to a complete track with 6000 data points). 200 points were randomly sampled from the "true" movement track, such that the intervals between locations are random with mean interval 0.3 units.
Usage
data(Simp)
Format
- Time
- times of observation 
- X, Y
- coordinates 
Source
simulated data
Examples
data(Simp)
plot(Simp)
Perform window sweep for BCPA
Description
This is the workhorse function of the BCPA. It performs a sweep of the time series, searching for most significant change points and identifying the parsimonious model according to an adjusted BIC.
Usage
WindowSweep(
  data,
  variable,
  time.var = "T.mid",
  windowsize = 50,
  windowstep = 1,
  units = "hours",
  K = 2,
  tau = TRUE,
  range = 0.6,
  progress = TRUE,
  plotme = FALSE,
  ...
)
Arguments
| data | the data to be analyzed.  Generically, the output of the 
 | 
| variable | a character string representing the response variable to 
apply the BCPA to.  For example  | 
| time.var | character string for the time variable.  The default is 
 | 
| windowsize | integer size of the analysis window as a number of data points (not time units). Should probably be no smaller than 20. | 
| windowstep | integer step size of analysis. Values greater than 1 speed the analysis up. | 
| units | if the times are POSIX,  | 
| K | sensitivity parameter for the adjusted BIC. Smaller values make for a less sensitive model selection, i.e. more likely that the null model of no significant changes will be selected. | 
| tau | a logical indicating whether the autocorrelation "rho" or the characteristic time "tau" should be estimated. | 
| range | a number between 0 and 1 that determines the extent of each 
window that is scanned for changepoints.  I.e., if the window is 100 
datapoints long, at the default  | 
| progress | logical - whether or not to output a progress bar as the analysis is being performed. | 
| plotme | logical - whether or not to plot the analysis as it is happening. This slows the analysis considerably, especially in non-dynamic graphic environments like RStudio. | 
| ... | additional parameters to be passed to the 
 | 
Value
an object of class windowsweep, which is a list containing: 
| ws | a data frame containing the change point, selected model, and parameter estimates | 
| x | the response variable | 
| t | the time variable - in the units specified in the data object | 
| t.POSIX | the time variable as a POSIX object (containing Y-M-D H:S) | 
| windowsize | the window size | 
| windowstep | the window step size | 
Author(s)
Eliezer Gurarie
See Also
for internal functions: GetModels, 
GetBestBreak, GetDoubleL; for summarizing 
output: ChangePointSummary; for plotting output: 
plot.bcpa
Examples
# Using the included simulated  movement data
require(bcpa)
data(Simp)
plot(Simp)
Simp.VT <- GetVT(Simp)
## note: column names of Simp.VT include:
###  "S" - step length
### "Theta" - turning angle
###  T.start" "T.end"   "T.mid"  "T.POSIX" - time variables
if(interactive())
  Simp.ws <- WindowSweep(Simp.VT, "V*cos(Theta)", windowsize = 50, 
                         windowstep = 1, progress=TRUE) else
  Simp.ws <- WindowSweep(Simp.VT, "V*cos(Theta)", windowsize = 50, 
                         windowstep = 1, progress=FALSE)
plot(Simp.ws, threshold = 7)
plot(Simp.ws, type = "flat", clusterwidth = 3)
PathPlot(Simp, Simp.ws)
PathPlot(Simp, Simp.ws, type="flat")
DiagPlot(Simp.ws)
# Example of application on one dimensional data (e.g. depth)
# simulate some data with three change points: surface, medium, deep, surface
## random times within 100 hours of now
n.obs <- 100
time = sort(Sys.time() - runif(n.obs, 0, n.obs) * 60 * 60)
d1 <- 50; d2 <- 100
t1 <- 25; t2 <- 65; t3 <- 85
sd1 <- 1; sd2 <- 5; sd3 <- 10
dtime <- as.numeric(difftime(time, min(time), units="hours"))
phases <- cut(dtime, c(-1, t1, t2, t3, 200), labels = c("P1","P2","P3","P4")) 
means <- c(0,d1,d2,0)[phases]
sds <- c(sd1,sd2,sd3,sd1)[phases]
depth <- rnorm(n.obs,means, sds)
# make all depths positive!
depth <- abs(depth)
mydata <- data.frame(time, depth)
# perform windowsweep
ws <- WindowSweep(mydata, "depth", time.var = "time", windowsize = 30, 
                  windowstep = 1, progress=interactive())
plot(ws)
plot(ws, type = "flat", cluster = 6)
ChangePointSummary(ws, cluster = 6)
Plotting method for BCPA output
Description
Plotting method for the output of a BCPA analysis with vertical break points, superimposed estimates of the partitioned mean and variance estimates and color-coded autocorrelation estimates.
Usage
## S3 method for class 'bcpa'
plot(
  x,
  type = c("smooth", "flat")[1],
  threshold = 3,
  clusterwidth = 1,
  col.cp = rgb(0.5, 0, 0.5, 0.5),
  pt.cex = 0.5,
  legend = TRUE,
  rho.where = "topleft",
  mu.where = "nowhere",
  col.sd = "red",
  col.mean = "black",
  ...
)
Arguments
| x | a  | 
| type | whether to plot smooth or flat bcpa output | 
| threshold | for smooth BCPA, this is the minimum number of windows that must have identified a given changepoint to be illustrated. | 
| clusterwidth | for flat BCPA, this is the temporal range within which change points are considered to be within the same cluster. | 
| col.cp,col.mean,col.sd | color of the vertical change points, mean estimate, and prediction interval (mu +- sigma), respectively. | 
| pt.cex | expansion coefficient for point sizes. | 
| legend | logical - whether to draw a legend or not. | 
| rho.where | where to place the legend for the time-scale / auto-correlation. Can be one of "nowhere", "top", "bottom", "left", "right", "topleft", "topright", "bottomright", "bottomleft" | 
| mu.where | where (and whether) to place the legend box for the mean - 
same options as for  | 
| ... | other arguments to pass to the  | 
Author(s)
Eliezer Gurarie
See Also
Plots output of the WindowSweep function.
Examples
if(!exists("Simp.ws"))
{
 data(Simp)
 Simp.ws <- WindowSweep(GetVT(Simp), "V*cos(Theta)", windowsize = 50, 
 windowstep = 1, progress=TRUE)
}
plot(Simp.ws)
# this actually provides basically the exact original changepoints
plot(Simp.ws, threshold=7)
# here's a flat analysis
plot(Simp.ws, type="flat", clusterwidth=3, legend=FALSE)
Plot Track
Description
Default method for plotting tracks
Usage
## S3 method for class 'track'
plot(x, pch = 19, col = rgb(0, 0, 0, 0.2), ...)
Arguments
| x | object of class "track" to plot | 
| pch | default point style: filled circle | 
| col | default color: transparent grey | 
| ... | other arguments to pass to  | 
Examples
data(Simp)
is(Simp)
plot(Simp)