Lower Columbia River Fish Population Indexing 2022
The suggested citation for this analytic appendix is:
Thorley, J.L., Dalgarno, S., Lyons, S. (2023) Lower Columbia River Fish Population Indexing 2022. A Poisson Consulting Analysis Appendix. URL: https://www.poissonconsulting.ca/f/1392245070.
Background
In the mid 1990s BC Hydro began operating Hugh L. Keenleyside (HLK) Dam to reduce dewatering of Mountain Whitefish and Rainbow Trout eggs.
The primary goal of the Lower Columbia River Fish Population Indexing program is to answer two key management questions:
What are the abundance, growth rate, survival rate, body condition, age distribution, and spatial distribution of subadult and adult Whitefish, Rainbow Trout, and Walleye in the Lower Columbia River?
What is the effect of inter-annual variability in the Whitefish and Rainbow Trout flow regimes on the abundance, growth rate, survival rate, body condition, and spatial distribution of subadult and adult Whitefish, Rainbow Trout, and Walleye in the Lower Columbia River?
The inter-annual variability in the Whitefish and Rainbow Trout flow regimes was quantified in terms of the percent egg dewatering as greater flow variability is associated with more egg stranding.
Methods
Data Preparation
The fish indexing data were provided by Okanagan Nation Alliance and Golder Associates in the form of an Access database. The discharge and temperature data were obtained from the Columbia Basin Hydrological Database maintained by Poisson Consulting. The Rainbow Trout egg dewatering estimates were provided by CLBMON-46 (Irvine, Baxter, and Thorley 2015) and the Mountain Whitefish egg stranding estimates by Golder Associates (2013).
The data were prepared for analysis using R version 4.3.0 (R Core Team 2018).
Discharge
Missing hourly discharge values for Hugh-Keenleyside Dam (HLK), Brilliant Dam (BRD) and Birchbank (BIR) were estimated by first leading the BIR values by 2 hours to account for the lag. Values missing at just one of the dams were then estimated assuming \(HLK + BRD = BIR\). Negative values were set to be zero. Next, missing values spanning \(\leq\) 28 days were estimated at HLK and BRD based on linear interpolation. Finally any remaining missing values at BIR were set to be \(HLK + BRD\).
Data Analysis
Model parameters were estimated using hierarchical Bayesian methods. The parameters were produced using JAGS (Plummer 2015) and STAN (Carpenter et al. 2017). For additional information on Bayesian estimation the reader is referred to McElreath (2016).
The one exception is the length-at-age estimates which were produced using the mixdist R package (P. Macdonald 2012) which implements Maximum Likelihood with Expectation Maximization.
Unless stated otherwise, the Bayesian analyses used weakly informative normal and half-normal prior distributions (Gelman, Simpson, and Betancourt 2017). The posterior distributions were estimated from 1500 Markov Chain Monte Carlo (MCMC) samples thinned from the second halves of 3 chains (Kery and Schaub 2011, 38–40). Model convergence was confirmed by ensuring that the potential scale reduction factor \(\hat{R} \leq 1.05\) (Kery and Schaub 2011, 40) and the effective sample size (Brooks et al. 2011) \(\textrm{ESS} \geq 150\) for each of the monitored parameters (Kery and Schaub 2011, 61).
The parameters are summarised in terms of the point estimate, lower and upper 95% credible limits (CLs) and the surprisal s-value (Greenland 2019). The estimate is the median (50th percentile) of the MCMC samples while the 95% CLs are the 2.5th and 97.5th percentiles. The s-value can be considered a test of directionality. More specifically it indicates how surprising (in bits) it would be to discover that the true value of the parameter is in the opposite direction to the estimate. An s-value (Chow and Greenland 2019) is the Shannon transform (-log to base 2) of the corresponding p-value (Kery and Schaub 2011; Greenland and Poole 2013). A surprisal value of 4.3 bits, which is equivalent to a p-value of 0.05 indicates that the surprise would be equivalent to throwing 4.3 heads in a row. The condition that non-essential explanatory variables have s-values \(\geq\) 4.3 bits provides a useful model selection heuristic (Kery and Schaub 2011).
Model adequacy was assessed via posterior predictive checks (Kery and Schaub 2011). More specifically, the number of zeros and the first four central moments (mean, variance, skewness and kurtosis) for the deviance residuals were compared to the expected values by simulating new residuals. In this context the s-value indicates how surprising each metric is given the estimated posterior probability distribution for the residual variation.
Where computationally practical, the sensitivity of the parameters to the choice of prior distributions was evaluated by increasing the standard deviations of all normal, half-normal and log-normal priors by an order of magnitude and then using \(\hat{R}\) to test whether the samples where drawn from the same posterior distribution (Thorley and Andrusak 2017).
The results are displayed graphically by plotting the modeled relationships between particular variables and the response(s) with the remaining variables held constant. In general, continuous and discrete fixed variables are held constant at their mean and first level values, respectively, while random variables are held constant at their typical values (expected values of the underlying hyperdistributions) (Kery and Schaub 2011, 77–82). When informative the influence of particular variables is expressed in terms of the effect size (i.e., percent or n-fold change in the response variable) with 95% credible intervals (CIs, Bradford, Korman, and Higgins 2005).
The analyses were implemented using R version 4.3.0
(R Core Team 2020) and the
mbr
family of packages.
Model Descriptions
Condition
The expected weight of fish of a given length were estimated from the data using an allometric mass-length model (He et al. 2008).
\[W = \alpha L^{\beta}\]
Key assumptions of the condition model include:
- The expected weight is allowed to vary with length and date.
- The expected weight is allowed to vary randomly with year.
- The relationship between weight and length is allowed to vary with date.
- The relationship between weight and length is allowed to vary randomly with year.
- The residual variation in weight is log-normally distributed.
Only previously untagged fish were included in models to avoid potential effects of tagging on body condition. Preliminary analyses indicated that the annual variation in weight was not correlated with the annual variation in the relationship between weight and length.
Growth
Annual growth of fish were estimated from the inter-annual recaptures using the Fabens method (Fabens 1965) for estimating the von Bertalanffy growth curve (von Bertalanffy 1938). This curve is based on the premise that:
\[ \frac{\text{d}L}{\text{d}t} = k (L_{\infty} - L)\]
where \(L\) is the length of the individual, \(k\) is the growth coefficient and \(L_{\infty}\) is the maximum length.
Integrating the above equation gives:
\[ L_t = L_{\infty} (1 - e^{-k(t - t_0)})\]
where \(L_t\) is the length at time \(t\) and \(t_0\) is the time at which the individual would have had zero length.
The Fabens form allows
\[ L_r = L_c + (L_{\infty} - L_c) (1 - e^{-kT})\]
where \(L_r\) is the length at recapture, \(L_c\) is the length at capture and \(T\) is the time between capture and recapture.
Key assumptions of the growth model include:
- The mean maximum length \(L_{\infty}\) is constant.
- The growth coefficient \(k\) is allowed to vary randomly with year.
- The residual variation in growth is normally distributed.
The growth model was only fitted to Walleye with a fork length at release less than 450 mm.
Movement
The extent to which sites are closed, i.e., fish remain at the same site between sessions, was evaluated with a logistic ANCOVA (Kery 2010). The model estimates the probability that intra-annual recaptures were caught at the same site versus a different one. Key assumptions of the site fidelity model include:
- The expected site fidelity is allowed to vary with fish length.
- Observed site fidelity is Bernoulli distributed.
Length as a second-order polynomial was not found to be a significant predictor for site fidelity.
The estimated probability of being caught at the same site versus a different site was then converted into the site fidelity by assuming that those fish which were recaught at a different site represented just 32 % of those that left the site. The correction factor corresponds to the proportion of the river bank that belongs to index sites.
Length-At-Age
The expected length-at-age of Mountain Whitefish and Rainbow Trout were estimated from annual length-frequency distributions using a finite mixture distribution model (P. D. M. Macdonald and Pitcher 1979)
There were assumed to be three distinguishable normally-distributed age-classes for Mountain Whitefish (Age-0, Age-1, Age-2 and Age-3+) two for Rainbow Trout (Age-0, Age-1, Age-2+). Initially the model was fitted to the data from all years combined. The model was then fitted to the data for each year separately with the initial values set to be the estimates from the combined values. The only constraints were that the standard deviations of the MW age-classes were identical in the combined analysis and fixed at the initial values in the individual years.
Rainbow Trout and Mountain Whitefish were categorized as Fry (Age-0), Juvenile (Age-1) and Adult (Age-2+) based on their length-based ages. All Walleye were considered to be Adults.
Survival
The annual adult survival rate was estimated by fitting a Cormack-Jolly-Seber model (Kery and Schaub 2011, 220–31) to inter-annual recaptures of adults.
Key assumptions of the survival model include:
- Survival varies randomly with year.
- The encounter probability for adults is allowed to vary with the total bank length sampled.
Preliminary analysis indicated that only including visits to index sites did not substantially change the results.
Observer Length Correction
The annual bias (inaccuracy) and error (imprecision) in observer’s fish length estimates were quantified from the divergence of the length distribution of their observed fish from the length distribution of the measured fish. More specifically, the length correction that minimised the Jensen-Shannon divergence (Lin 1991) between the two distributions provided a measure of the inaccuracy while the minimum divergence (the Jensen-Shannon divergence was calculated with log to base 2 which means it lies between 0 and 1) provided a measure of the imprecision.
Capture Efficiency
The probability of capture was estimated using a recapture-based binomial model (Kery and Schaub 2011, 134–36, 384–88).
Key assumptions of the capture efficiency model include:
- The capture probability varies randomly by session within year.
- The probability of a marked fish remaining at a site is the estimated site fidelity.
- The number of recaptures is described by a binomial distribution.
Preliminary analyses indicated that the direction of effect of the frequency of the electrofishing current (30, 60 or 120 Hz) was uncertain.
Abundance
The abundance was estimated from the catch and bias-corrected observer count data using an overdispersed Poisson model (Kery and Schaub 2011, 55–56).
Key assumptions of the abundance model include:
- The fish density varies randomly with site, year and site within year.
- The change in fish density with overall abundance varies by site density.
- The capture efficiency at a typical fish density is the point estimate for a typical session from the capture efficiency model.
- The count efficiency varies from the capture efficiency.
- The capture efficiency (but not the count efficiency) varies with density.
- The overdispersion varies by visit type (count or catch).
- The catches and counts are described by a gamma-Poisson distribution.
Distribution
The distribution was calculated in terms of the Shannon index of evenness in each year for each species and life-stage. The index was calculated using the following formula where \(S\) is the number of sites and \(p_i\) is the proportion of the total density belonging to the ith site
\[ E = \frac{-\sum p_i \log(p_i)}{\log(S)}\]
Survival (Abundance-based)
The subadult (\(S_t\)) and adult (\(A_t\)) abundance estimates were used to calculate the subadult and adult survival (\(\phi_t\)) in year \(t\) based on the relationship
\[\phi_t = \frac{A_t}{S_{t-1} + A_{t-1}}\]
Weight
The weight (\(W_t\)) in year \(t\) was estimated from the expected adult length using the condition model.
Fecundity
Mountain Whitefish
The fecundity-weight relationship for Mountain Whitefish was estimated from data collected by Boyer et al. (2017) for the Madison River, Montana. The data were analysed using an allometric model of the form
\[F = \alpha W^{\beta}\]
Key assumptions of the fecundity model include:
- The residual variation in fecundity is log-normally distributed.
Rainbow Trout
Following (Andrusak and Thorley 2019) the fecundity (\(F_t\)) in year \(t\) of an adult female Rainbow Trout was calculated from the expected weight (\(W_t\)) in grams using the equation:
\[F_t = 3.8 \cdot W_t^{0.9}\]
Egg Deposition
The total egg deposition (\(E_t\)) in year \(t\) was calculated according to the equation \[E_t = F_t * \frac{A_t}{2}\]
Stock-Recruitment
The relationship between the total number of eggs deposited (\(E_t\)) and the resultant number of subadults (age-1 recruits) (\(S_{t+1}\)) was estimated using a Beverton-Holt stock-recruitment model (Walters and Martell 2004):
\[S_{t+1} = \frac{\alpha \cdot E_t}{1 + \beta \cdot E_t}\]
where \(\alpha\) is the egg to age-1 survival at low density and \(\beta\) is the density-dependence.
Key assumptions of the stock-recruitment model include:
- The egg to recruit survival at low density (\(\alpha\)) was likely less than 1% (the prior distribution for \(\alpha\) was a zero truncated normal with standard deviation of 0.005.
- The expected log number of recruits varies with the proportional egg loss.
- The residual variation in the number of recruits is log-normally distributed.
The expected egg survival for a given egg deposition is \(S / E_t\) which is given by the equation
\[\phi_E = \frac{\alpha}{1 + \beta * E}\]
Age-Ratios
The proportion of Age-1 Mountain Whitefish \(r^1_t\) from a given spawn year \(t\) is calculated from the relative abundance of Age-1 & Age-2 fish \(N^1_t\) & \(N^2_t\) respectively, which were lead or lagged so that all values were with respect to the spawn year:
\[r^1_t = \frac{N^1_{t+2}}{N^1_{t+2} + N^2_{t+2}}\]
The relative abundances of Age-1 and Age-2 fish were taken from the proportions of each age-class in the length-at-age analysis.
As the number of Age-2 fish might be expected to be influenced by the percentage egg loss \(Q_t\) three years prior, the predictor variable \(\Pi_t\) used is:
\[\Pi_t = \textrm{log}(Q_t/Q_{t-1})\]
The ratio was logged to ensure it was symmetrical about zero (Tornqvist, Vartia, and Vartia 1985).
The relationship between \(r^1_t\) and \(\Pi_t\) was estimated using a Bayesian regression (Kery 2010) loss model.
Key assumptions of the final model include:
- The log odds of the proportion of Age-1 fish varies with the log of the ratio of the percent egg losses.
- The residual variation is normally distributed.
The relationship between percent dewatering and subsequent recruitment is expected to depend on stock abundance (Subbey et al. 2014) which might be changing over the course of the study. Consequently, preliminary analyses allowed the slope of the regression line to change by year. However, year was not a significant predictor and was therefore removed from the final model. The effect of dewatering on Mountain Whitefish abundance was expressed in terms of the predicted percent change in Age-1 Mountain Whitefish abundance by egg loss in the spawn year relative to 10% egg loss in the spawn year. The egg loss in the previous year was fixed at 10%. The percent change could not be calculated relative to 0% in the spawn or previous year as \(\Pi_t\) is undefined in either case.
Adjusted Recruitment
The abundance of Age-1 Rainbow Trout was estimated based on the proportion of the Rainbow Trout eggs dewatered the previous year and the abundance of age-1 Mountain Whitefish caught in the same year to account for inter-annual variation in age-1 salmonid abundance and/or capture efficiency.
The relationship(s) were estimated using a Generalized Linear Model (GLM).
Key assumptions of the final model include:
- The abundance of Age-1 Rainbow Trout varies with proportion of the eggs dewatered and then number of Age-1 Mountain Whitefish caught in the same year.
- The residual variation is log-normally distributed.
Model Templates
Condition
data {
int nYear;
int nObs;
vector[nObs] Length;
vector[nObs] Weight;
vector[nObs] Dayte;
int Year[nObs];
parameters {
real bWeight;
real bWeightLength;
real bWeightDayte;
real bWeightLengthDayte;
real<lower=0> sWeightYear;
real<lower=0> sWeightLengthYear;
vector[nYear] bWeightYear;
vector[nYear] bWeightLengthYear;
real<lower=0> sWeight;
model {
vector[nObs] eWeight;
bWeight ~ normal(5, 4);
bWeightLength ~ normal(3, 1);
bWeightDayte ~ normal(0, 1);
bWeightLengthDayte ~ normal(0, 1);
sWeightYear ~ normal(0, 1);
sWeightLengthYear ~ normal(0, 1);
for (i in 1:nYear) {
bWeightYear[i] ~ normal(0, sWeightYear);
bWeightLengthYear[i] ~ normal(0, sWeightLengthYear);
}
sWeight ~ normal(0, 5);
for(i in 1:nObs) {
eWeight[i] = bWeight + bWeightDayte * Dayte[i] + bWeightYear[Year[i]] + (bWeightLength + bWeightLengthDayte * Dayte[i] + bWeightLengthYear[Year[i]]) * Length[i];
Weight[i] ~ lognormal(eWeight[i], sWeight);
}
Block 1. Model description.
Growth
.model {
bK ~ dnorm (0, 5^-2)
sKYear ~ dnorm(0, 2^-2) T(0,)
for (i in 1:nYear) {
bKYear[i] ~ dnorm(0, sKYear^-2)
log(eK[i]) <- bK + bKYear[i]
}
bLinf ~ dunif(200, 1000)
sGrowth ~ dnorm(0, 25^-2) T(0,)
for (i in 1:length(Year)) {
eGrowth[i] <- max(0, (bLinf - LengthAtRelease[i]) * (1 - exp(-sum(eK[Year[i]:(Year[i] + dYears[i] - 1)]))))
Growth[i] ~ dnorm(eGrowth[i], sGrowth^-2)
}
Block 2.
Movement
.model {
bFidelity ~ dnorm(0, 1^-2)
bLength ~ dnorm(0, 1^-2)
for (i in 1:length(Fidelity)) {
logit(eFidelity[i]) <- bFidelity + bLength * Length[i]
Fidelity[i] ~ dbern(eFidelity[i])
}
Block 3.
Survival
.model{
bEfficiency ~ dnorm(0, 4^-2)
bEfficiencySampledLength ~ dnorm(0, 4^-2)
bSurvival ~ dnorm(0, 4^-2)
sSurvivalYear ~ dnorm(0, 4^-2) T(0,)
for(i in 1:nYear) {
bSurvivalYear[i] ~ dnorm(0, sSurvivalYear^-2)
}
for(i in 1:(nYear-1)) {
logit(eEfficiency[i]) <- bEfficiency + bEfficiencySampledLength * SampledLength[i]
logit(eSurvival[i]) <- bSurvival + bSurvivalYear[i]
eProbability[i,i] <- eSurvival[i] * eEfficiency[i]
for(j in (i+1):(nYear-1)) {
eProbability[i,j] <- prod(eSurvival[i:j]) * prod(1-eEfficiency[i:(j-1)]) * eEfficiency[j]
}
for(j in 1:(i-1)) {
eProbability[i,j] <- 0
}
}
for(i in 1:(nYear-1)) {
eProbability[i,nYear] <- 1 - sum(eProbability[i,1:(nYear-1)])
}
for(i in 1:(nYear - 1)) {
Marray[i, 1:nYear] ~ dmulti(eProbability[i,], Released[i])
}
Block 4.
Capture Efficiency
.model {
bEfficiency ~ dnorm(-4, 2^-2)
sEfficiencySessionAnnual ~ dnorm(0, 1^-2) T(0,)
for (i in 1:nSession) {
for (j in 1:nAnnual) {
bEfficiencySessionAnnual[i, j] ~ dnorm(0, sEfficiencySessionAnnual^-2)
}
}
for (i in 1:length(Recaptures)) {
logit(eEfficiency[i]) <- bEfficiency + bEfficiencySessionAnnual[Session[i], Annual[i]]
eFidelity[i] ~ dnorm(Fidelity[i], FidelitySD[i]^-2) T(FidelityLower[i], FidelityUpper[i])
Recaptures[i] ~ dbin(eEfficiency[i] * eFidelity[i], Tagged[i])
}
Block 5.
Abundance
.model {
bDensity ~ dnorm(5, 4^-2)
bDensitySiteAnnual2 ~ dnorm(0, 2^-2)
sDensityAnnual ~ dnorm(0, 1^-2) T(0,)
for (i in 1:nAnnual) {
bDensityAnnual[i] ~ dnorm(0, sDensityAnnual^-2)
}
sDensitySite ~ dnorm(0, 1^-2) T(0,)
sDensitySiteAnnual ~ dnorm(0, 1^-2) T(0,)
for (i in 1:nSite) {
bDensitySite[i] ~ dnorm(0, sDensitySite^-2)
for (j in 1:nAnnual) {
bDensitySiteAnnual[i, j] ~ dnorm(0, sDensitySiteAnnual^-2)
}
}
bEfficiencyVisitType[1] <- 0
bEfficiencyVisitTypeDensity[1] ~ dnorm(0, 2^-2)
for (i in 2:nVisitType) {
bEfficiencyVisitType[i] ~ dnorm(0, 2^-2)
bEfficiencyVisitTypeDensity[i] <- 0
}
sDispersion ~ dnorm(0, 1^-2)
sDispersionVisitType[1] <- 0
for(i in 2:nVisitType) {
sDispersionVisitType[i] ~ dnorm(0, 2^-2)
}
for (i in 1:length(Fish)) {
log(eDensity[i]) <- bDensity + bDensitySite[Site[i]] + bDensityAnnual[Annual[i]] + bDensitySiteAnnual[Site[i],Annual[i]] + bDensitySiteAnnual2 * exp(bDensity + bDensitySite[Site[i]]) * bDensityAnnual[Annual[i]]
eAbundance[i] <- eDensity[i] * SiteLength[i]
logit(eEfficiency[i]) <- logit(Efficiency[i]) + bEfficiencyVisitType[VisitType[i]] + bEfficiencyVisitTypeDensity[VisitType[i]] * (eDensity[i] - exp(bDensity + sDensityAnnual^2/2 + sDensitySite^2/2 + sDensitySiteAnnual^2/2))
log(esDispersion[i]) <- sDispersion + sDispersionVisitType[VisitType[i]]
eDispersion[i] ~ dgamma(esDispersion[i]^-2 + 0.1, esDispersion[i]^-2 + 0.1)
eFish[i] <- eAbundance[i] * ProportionSampled[i] * eEfficiency[i]
Fish[i] ~ dpois(eFish[i] * eDispersion[i])
}
Block 6.
Fecundity
model {
bFecundity ~ dnorm(0, 5^-2)
bFecundityWeight ~ dnorm(1, 1^-2) T(0,)
sFecundity ~ dnorm(0, 1^-2) T(0,)
for(i in 1:length(Weight)) {
eFecundity[i] = bFecundity + bFecundityWeight * log(Weight[i])
Fecundity[i] ~ dlnorm(eFecundity[i], sFecundity^-2)
}
Block 7.
Stock-Recruitment
.model {
bAlpha ~ dnorm(0, 0.003^-2) T(0,)
bBeta ~ dnorm(0, 0.007^-2) T(0, )
bEggLoss ~ dnorm(0, 100^-2)
sRecruits ~ dnorm(0, 1^-2) T(0,)
for(i in 1:length(Recruits)){
log(eRecruits[i]) <- log(bAlpha * Eggs[i] / (1 + bBeta * Eggs[i])) + bEggLoss * EggLoss[i]
Recruits[i] ~ dlnorm(log(eRecruits[i]), sRecruits^-2)
}
Block 8.
Age-Ratios
.model{
bProbAge1 ~ dnorm(0, 1^-2)
bProbAge1Loss ~ dnorm(0, 1^-2)
sProbAge1 ~ dnorm(0, 1^-2) T(0,)
for(i in 1:length(Age1Prop)){
eAge1Prop[i] <- bProbAge1 + bProbAge1Loss * LossLogRatio[i]
Age1Prop[i] ~ dnorm(eAge1Prop[i], sProbAge1^-2)
}
Block 9.
Adjusted Recruitment
.model{
b0 ~ dnorm(0, 10^-2)
bMw ~ dnorm(0, 2^-2)
bEggLoss ~ dnorm(0, 2^-2)
sRb ~ dnorm(0, 2^-2) T(0,)
for (i in 1:nObs) {
log(eRb[i]) <- b0 + bMw * Mw[i] + bEggLoss * EggLoss[i]
Rb[i] ~ dlnorm(log(eRb[i]), sRb^-2)
}
Block 10. Model description.
Results
Tables
Condition
Table 1. Parameter descriptions.
Parameter | Description |
---|---|
Dayte[i] |
Standardised day of year i th fish was captured |
Length[i] |
Log-transformed and centered fork length of i th
fish |
Weight[i] |
Recorded weight of i th fish |
Year[i] |
Year i th fish was captured |
bWeightDayte |
Effect of Dayte on bWeight |
bWeightLengthDayte |
Effect of Dayte on bWeightLength |
bWeightLengthYear[i] |
Effect of i th Year on bWeightLength |
bWeightLength |
Intercept of effect of Length on bWeight |
bWeightYear[i] |
Effect of i th Year on bWeight |
bWeight |
Intercept of log(eWeight) |
eWeight[i] |
Expected Weight of i th fish |
sWeightLengthYear |
Log standard deviation of bWeightLengthYear |
sWeightYear |
Log standard deviation of bWeightYear |
sWeight |
Log standard deviation of residual variation in
log(Weight) |
Mountain Whitefish
Table 2. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bWeight | 5.4732409 | 5.4547642 | 5.4935278 | 10.55171 |
bWeightDayte | -0.0203585 | -0.0237843 | -0.0171574 | 10.55171 |
bWeightLength | 3.1698089 | 3.1228550 | 3.2100053 | 10.55171 |
bWeightLengthDayte | -0.0206998 | -0.0296748 | -0.0115355 | 10.55171 |
sWeight | 0.1463908 | 0.1447608 | 0.1479743 | 10.55171 |
sWeightLengthYear | 0.1094173 | 0.0800618 | 0.1553615 | 10.55171 |
sWeightYear | 0.0485446 | 0.0365079 | 0.0672782 | 10.55171 |
Table 3. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
16748 | 7 | 3 | 500 | 2 | 330 | 1.013 | TRUE |
Table 4. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 0.0001197 | -0.0001267 | -0.0151571 | 0.0149550 | 0.0409441 |
variance | 0.9973298 | 1.0001656 | 0.9798047 | 1.0214428 | 0.3192873 |
skewness | -0.6017602 | -0.0001625 | -0.0374198 | 0.0364191 | 10.5517083 |
kurtosis | 1.8037636 | -0.0019891 | -0.0724094 | 0.0731123 | 10.5517083 |
Table 5. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.013 | 1.016 | 1.01 |
Rainbow Trout
Table 6. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bWeight | 6.0370978 | 6.0270566 | 6.0475897 | 10.55171 |
bWeightDayte | -0.0039410 | -0.0061160 | -0.0017446 | 10.55171 |
bWeightLength | 2.9264697 | 2.9052969 | 2.9479187 | 10.55171 |
bWeightLengthDayte | 0.0380958 | 0.0312706 | 0.0443072 | 10.55171 |
sWeight | 0.0999041 | 0.0988578 | 0.1009943 | 10.55171 |
sWeightLengthYear | 0.0517524 | 0.0370216 | 0.0733665 | 10.55171 |
sWeightYear | 0.0249434 | 0.0186728 | 0.0347163 | 10.55171 |
Table 7. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
18015 | 7 | 3 | 500 | 2 | 334 | 1.015 | TRUE |
Table 8. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 0.0003917 | 0.0000477 | -0.0144834 | 0.0149080 | 0.0830842 |
variance | 0.9970646 | 1.0006205 | 0.9798205 | 1.0202371 | 0.4444912 |
skewness | -0.6767363 | 0.0003559 | -0.0347633 | 0.0356899 | 10.5517083 |
kurtosis | 2.2597359 | -0.0012144 | -0.0660660 | 0.0765119 | 10.5517083 |
Table 9. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.015 | 1.007 | 1.007 |
Walleye
Table 10. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bWeight | 6.2931412 | 6.2784639 | 6.3082132 | 10.551708 |
bWeightDayte | 0.0154347 | 0.0130148 | 0.0178195 | 10.551708 |
bWeightLength | 3.2299131 | 3.1996511 | 3.2615267 | 10.551708 |
bWeightLengthDayte | -0.0057003 | -0.0203522 | 0.0090376 | 1.191959 |
sWeight | 0.0918887 | 0.0906741 | 0.0931940 | 10.551708 |
sWeightLengthYear | 0.0727259 | 0.0512623 | 0.1036775 | 10.551708 |
sWeightYear | 0.0353325 | 0.0271249 | 0.0489660 | 10.551708 |
Table 11. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
10635 | 7 | 3 | 500 | 2 | 256 | 1.014 | TRUE |
Table 12. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 0.0004620 | 0.0002671 | -0.0171674 | 0.0199111 | 0.0330551 |
variance | 0.9957787 | 1.0006582 | 0.9741117 | 1.0263279 | 0.4655720 |
skewness | -0.0187410 | -0.0010659 | -0.0458653 | 0.0452100 | 1.2365587 |
kurtosis | 0.9703957 | -0.0024500 | -0.0918807 | 0.0940346 | 10.5517083 |
Table 13. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.014 | 1.005 | 1.01 |
Growth
Table 14. Parameter descriptions.
Parameter | Description |
---|---|
Growth[i] |
Observed growth between release and recapture of
i th recapture |
LengthAtRelease[i] |
Length at previous release of i th recapture |
Year[i] |
Release year of i th recapture |
bKYear[i] |
Effect of i th Year on bK |
bK |
Intercept of log(eK) |
bLinf |
Mean maximum length |
dYears[i] |
Years between release and recapture of i th
recapture |
eGrowth |
Expected Growth between release and recapture |
eK[i] |
Expected von Bertalanffy growth coefficient from
i-1 th to i th year |
sGrowth |
Log standard deviation of residual variation in
Growth |
sKYear |
Log standard deviation of bKYear |
Mountain Whitefish
Table 15. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bK | -0.9384301 | -1.1484168 | -0.7404093 | 10.55171 |
bLinf | 399.3945885 | 393.9249703 | 404.2050797 | 10.55171 |
sGrowth | 11.5473791 | 10.6856803 | 12.6933727 | 10.55171 |
sKYear | 0.3869568 | 0.2565911 | 0.5909488 | 10.55171 |
Table 16. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
298 | 4 | 3 | 500 | 50 | 938 | 1.002 | TRUE |
Table 17. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0268456 | 0.0000000 | 0.0000000 | 0.0000000 | 10.5517083 |
mean | 0.0369528 | -0.0012119 | -0.1193993 | 0.1115377 | 0.9241744 |
variance | 0.9355362 | 0.9927556 | 0.8435511 | 1.1775451 | 1.0538564 |
skewness | -0.2212812 | -0.0064231 | -0.2617183 | 0.2655630 | 3.4121569 |
kurtosis | 0.4357409 | -0.0645029 | -0.4722527 | 0.5628374 | 3.0048138 |
Table 18. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.002 | 1.004 | 1.002 |
Rainbow Trout
Table 19. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bK | -0.1091626 | -0.2568478 | 0.0412570 | 2.816999 |
bLinf | 480.7711096 | 476.0357000 | 485.3382333 | 10.551708 |
sGrowth | 29.9495580 | 28.8233850 | 31.0386148 | 10.551708 |
sKYear | 0.3014960 | 0.2208877 | 0.4419149 | 10.551708 |
Table 20. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
1479 | 4 | 3 | 500 | 50 | 994 | 1.003 | TRUE |
Table 21. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0047329 | 0.0000000 | 0.0000000 | 0.0000000 | 10.5517083 |
mean | 0.0113159 | -0.0007548 | -0.0489893 | 0.0500167 | 0.6493331 |
variance | 0.9832970 | 0.9995337 | 0.9272834 | 1.0759454 | 0.6048020 |
skewness | 0.2639783 | -0.0017621 | -0.1230891 | 0.1249517 | 10.5517083 |
kurtosis | 0.6337016 | -0.0127135 | -0.2312639 | 0.2744559 | 10.5517083 |
Table 22. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.003 | 1.004 | 1.002 |
Walleye
Table 23. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bK | -2.4702742 | -2.9888898 | -2.0531680 | 10.55171 |
bLinf | 725.0025161 | 615.7184191 | 935.5042341 | 10.55171 |
sGrowth | 17.6588686 | 16.2562102 | 19.2704080 | 10.55171 |
sKYear | 0.3160298 | 0.1960807 | 0.4982604 | 10.55171 |
Table 24. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
293 | 4 | 3 | 500 | 50 | 285 | 1.017 | TRUE |
Table 25. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0068259 | 0.0000000 | 0.0000000 | 0.0000000 | 10.551708 |
mean | 0.0458839 | -0.0009061 | -0.1241999 | 0.1136060 | 1.310917 |
variance | 0.9357665 | 0.9965045 | 0.8463250 | 1.1696999 | 1.140197 |
skewness | 0.1750667 | -0.0049900 | -0.2699366 | 0.2805990 | 2.155104 |
kurtosis | 1.5559537 | -0.0476233 | -0.4748618 | 0.6507876 | 8.966746 |
Table 26. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.017 | 1.009 | 1.014 |
Movement
Table 27. Parameter descriptions.
Parameter | Description |
---|---|
Fidelity[i] |
Whether the i th recapture was encountered at the same
site as the previous encounter |
Length[i] |
Length at previous encounter of i th recapture |
bFidelity |
Intercept of logit(eFidelity) |
bLength |
Effect of length on logit(eFidelity) |
eFidelity[i] |
Expected site fidelity of i th recapture |
Mountain Whitefish
Table 28. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bFidelity | -0.2657959 | -0.6044753 | 0.0708722 | 3.0048138 |
bLength | -0.0453499 | -0.4329178 | 0.2909701 | 0.3289134 |
Table 29. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
131 | 2 | 3 | 500 | 1 | 770 | 1.002 | TRUE |
Table 30. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.5648855 | 0.5648855 | 0.4427481 | 0.6793893 | 0.0193523 |
mean | -0.0427948 | -0.0421908 | -0.2553256 | 0.1598318 | 0.0019236 |
variance | 1.3766540 | 1.3649081 | 1.2104312 | 1.4087225 | 0.4159990 |
skewness | 0.2617577 | 0.2617691 | -0.1991201 | 0.7783710 | 0.0019236 |
kurtosis | -1.9299736 | -1.9011336 | -1.9975464 | -1.3654516 | 0.3097251 |
Table 31. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.002 | 1.001 | 1.002 |
Rainbow Trout
Table 32. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bFidelity | 0.6946167 | 0.5443672 | 0.8499499 | 10.55171 |
bLength | -0.3293639 | -0.4721354 | -0.1688172 | 10.55171 |
Table 33. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
856 | 2 | 3 | 500 | 1 | 861 | 1.006 | TRUE |
Table 34. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.3352804 | 0.3376168 | 0.2897196 | 0.3808411 | 0.1035920 |
mean | 0.1058443 | 0.1020926 | 0.0312593 | 0.1760155 | 0.1433785 |
variance | 1.2415013 | 1.2431609 | 1.1515570 | 1.3110939 | 0.0468893 |
skewness | -0.6874727 | -0.6829440 | -0.9075806 | -0.4890093 | 0.0568527 |
kurtosis | -1.4645190 | -1.4663365 | -1.7021816 | -1.0965910 | 0.0154610 |
Table 35. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.006 | 1.001 | 1.003 |
Walleye
Table 36. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bFidelity | 0.6571219 | 0.3775618 | 0.9239956 | 10.5517083 |
bLength | -0.0806242 | -0.3202032 | 0.1809377 | 0.9837522 |
Table 37. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
237 | 2 | 3 | 500 | 1 | 978 | 1 | TRUE |
Table 38. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.3417722 | 0.3417722 | 0.2573840 | 0.4303797 | 0.0000000 |
mean | 0.1019739 | 0.1015907 | -0.0462431 | 0.2401701 | 0.0077098 |
variance | 1.2775310 | 1.2765889 | 1.1139577 | 1.3768625 | 0.0135193 |
skewness | -0.6673407 | -0.6644430 | -1.0602884 | -0.2712075 | 0.0468893 |
kurtosis | -1.5508735 | -1.5503584 | -1.9126616 | -0.8350748 | 0.0019236 |
Table 39. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1 | 1.002 | 1 |
Length-At-Age
Mountain Whitefish
Table 40. The estimated upper length cutoffs (mm) by age and year.
Year | Age0 | Age1 | Age2 |
---|---|---|---|
1990 | 163 | 275 | NA |
1991 | 144 | 226 | 296 |
2001 | 141 | 257 | 343 |
2002 | 163 | 260 | 343 |
2003 | 159 | 263 | 353 |
2004 | 158 | 249 | 342 |
2005 | 168 | 263 | 362 |
2006 | 175 | 284 | 357 |
2007 | 171 | 279 | 337 |
2008 | 170 | 248 | 341 |
2009 | 169 | 265 | 355 |
2010 | 177 | 272 | 353 |
2011 | 163 | 269 | 349 |
2012 | 162 | 268 | 347 |
2013 | 185 | 282 | 350 |
2014 | 178 | 283 | 362 |
2015 | 167 | 278 | 366 |
2016 | 165 | 283 | 352 |
2017 | 158 | 269 | 354 |
2018 | 177 | 262 | 346 |
2019 | 188 | 281 | 363 |
2020 | 167 | 291 | 365 |
2021 | 165 | 275 | 350 |
2022 | 162 | 272 | 346 |
Rainbow Trout
Table 41. The estimated upper length cutoffs (mm) by age and year.
Year | Age0 | Age1 |
---|---|---|
1990 | 154 | 356 |
1991 | 129 | 348 |
2001 | 133 | 327 |
2002 | 154 | 352 |
2003 | 161 | 345 |
2004 | 142 | 335 |
2005 | 163 | 349 |
2006 | 170 | 367 |
2007 | 165 | 378 |
2008 | 145 | 342 |
2009 | 146 | 342 |
2010 | 143 | 340 |
2011 | 155 | 347 |
2012 | 151 | 347 |
2013 | 169 | 358 |
2014 | 154 | 341 |
2015 | 166 | 338 |
2016 | 154 | 340 |
2017 | 132 | 320 |
2018 | 138 | 313 |
2019 | 160 | 318 |
2020 | 154 | 350 |
2021 | 168 | 349 |
2022 | 140 | 354 |
Survival
Table 42. Parameter descriptions.
Parameter | Description |
---|---|
SampledLength |
Total standardised length of river sampled |
bEfficiencySampledLength |
Effect of SampledLength on bEfficiency |
bEfficiency |
Intercept for logit(eEfficiency) |
bSurvivalYear[i] |
Effect of Year on bSurvival |
bSurvival |
Intercept for logit(eSurvival) |
eEfficiency[i] |
Expected recapture probability in i th year |
eSurvival[i] |
Expected survival probability from i-1 th to
i th year |
sSurvivalYear |
Log SD of bSurvivalYear |
Mountain Whitefish
Table 43. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -4.2707306 | -4.4595929 | -4.0944209 | 10.551708 |
bEfficiencySampledLength | 0.4020345 | 0.1769052 | 0.6036249 | 10.551708 |
bSurvival | 0.8816300 | 0.2801552 | 1.7311084 | 6.464245 |
sSurvivalYear | 1.2104642 | 0.6351825 | 2.2528623 | 10.551708 |
Table 44. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
21 | 4 | 3 | 500 | 200 | 1272 | 1.005 | TRUE |
Rainbow Trout
Table 45. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -2.5300941 | -2.6847303 | -2.3822189 | 10.5517083 |
bEfficiencySampledLength | 0.0344673 | -0.1081122 | 0.1773570 | 0.6890709 |
bSurvival | -0.4514088 | -0.6572149 | -0.2228691 | 8.9667458 |
sSurvivalYear | 0.3798247 | 0.2127659 | 0.6245149 | 10.5517083 |
Table 46. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
21 | 4 | 3 | 500 | 200 | 1300 | 1.003 | TRUE |
Walleye
Table 47. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -3.4860038 | -3.6692440 | -3.2909426 | 10.551708 |
bEfficiencySampledLength | 0.1423139 | -0.0109218 | 0.2961277 | 3.757292 |
bSurvival | 0.1328372 | -0.1631503 | 0.4713474 | 1.565866 |
sSurvivalYear | 0.5107776 | 0.2233458 | 0.9176983 | 10.551708 |
Table 48. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
21 | 4 | 3 | 500 | 200 | 1233 | 1.003 | TRUE |
Capture Efficiency
Table 49. Parameter descriptions.
Parameter | Description |
---|---|
Annual[i] |
Year of i th visit |
FidelitySD[i] |
SD of site fidelity on i th visit |
Fidelity[i] |
Mean site fidelity on i th visit |
Recaptures[i] |
Number of marked fish recaught during i th
visit |
Session[i] |
Session of i th visit |
Tagged[i] |
Number of marked fish tagged prior to i th
visit |
bEfficiencySessionAnnual |
Effect of Session within Annual on
logit(eEfficiency) |
bEfficiency |
Intercept for logit(eEfficiency) |
eEfficiency[i] |
Expected efficiency on i th visit |
eFidelity[i] |
Expected site fidelity on i th visit |
sEfficiencySessionAnnual |
SD of bEfficiencySessionAnnual |
Mountain Whitefish
Subadult
Table 50. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -4.3284960 | -4.8490697 | -3.934985 | 10.55171 |
sEfficiencySessionAnnual | 0.5343559 | 0.0348258 | 1.216418 | 10.55171 |
Table 51. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
1611 | 2 | 3 | 500 | 100 | 316 | 1.004 | TRUE |
Table 52. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.004 | 1.011 | 1.01 |
Adult
Table 53. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -4.4636275 | -4.7575859 | -4.1899651 | 10.55171 |
sEfficiencySessionAnnual | 0.2198811 | 0.0058236 | 0.6827221 | 10.55171 |
Table 54. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
1810 | 2 | 3 | 500 | 100 | 176 | 1.014 | TRUE |
Table 55. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.014 | 1.016 | 1.013 |
Rainbow Trout
Subadult
Table 56. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -3.0401384 | -3.1648924 | -2.9174620 | 10.55171 |
sEfficiencySessionAnnual | 0.4017667 | 0.2982203 | 0.5523378 | 10.55171 |
Table 57. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
1851 | 2 | 3 | 500 | 100 | 1172 | 1.004 | TRUE |
Table 58. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.004 | 1.006 | 1.003 |
Adult
Table 59. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -3.457437 | -3.587065 | -3.3351777 | 10.55171 |
sEfficiencySessionAnnual | 0.160002 | 0.007375 | 0.3909227 | 10.55171 |
Table 60. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
1929 | 2 | 3 | 500 | 100 | 292 | 1.019 | TRUE |
Table 61. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.019 | 1.007 | 1.012 |
Walleye
Table 62. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bEfficiency | -3.9245961 | -4.1742563 | -3.716280 | 10.55171 |
sEfficiencySessionAnnual | 0.5734736 | 0.3653922 | 0.829421 | 10.55171 |
Table 63. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
1971 | 2 | 3 | 500 | 100 | 1214 | 1.005 | TRUE |
Table 64. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.005 | 1.005 | 1.003 |
Abundance
Table 65. Parameter descriptions.
Parameter | Description |
---|---|
Annual |
Year |
Efficiency |
Capture efficiency |
Fish |
Number of fish captured or counted |
ProportionSampled |
Proportion of site surveyed |
SiteLength |
Length of site |
Site |
Site |
VisitType |
Survey type (catch versus count) |
bDensityAnnual |
Effect of Annual on bDensity |
bDensitySiteAnnual |
Effect of Site within Annual on bDensity |
bDensitySite |
Effect of Site on bDensity |
bDensity |
Intercept for log(eDensity) |
bEfficiencyVisitType |
Effect of VisitType on Efficiency |
eDensity |
Expected density |
esDispersion |
Overdispersion of Fish |
sDensityAnnual |
Log SD of effect of Annual on bDensity |
sDensitySiteAnnual |
Log SD of effect of Site within Annual on
bDensity |
sDensitySite |
Log SD of effect of Site on bDensity |
sDispersionVisitType |
Effect of VisitType on sDispersion |
sDispersion |
Intercept for log(esDispersion) |
Mountain Whitefish
Subadult
Table 66. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bDensity | 4.7654135 | 4.4298072 | 5.1118994 | 10.551708 |
bDensitySiteAnnual2 | 0.0004267 | -0.0002978 | 0.0014276 | 1.970508 |
bEfficiencyVisitType[2] | 1.3070680 | 1.1847237 | 1.4435341 | 10.551708 |
bEfficiencyVisitTypeDensity[1] | 0.0000286 | -0.0001100 | 0.0003042 | 0.365594 |
sDensityAnnual | 0.6077907 | 0.4450699 | 0.8612345 | 10.551708 |
sDensitySite | 0.8038636 | 0.6594168 | 0.9823473 | 10.551708 |
sDensitySiteAnnual | 0.4287876 | 0.3789356 | 0.4819790 | 10.551708 |
sDispersion | -0.8066521 | -0.9006505 | -0.7254798 | 10.551708 |
sDispersionVisitType[2] | 0.6498328 | 0.4794663 | 0.8151093 | 10.551708 |
Table 67. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
3176 | 9 | 3 | 500 | 300 | 380 | 1.009 | TRUE |
Table 68. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.2399244 | 0.2660579 | 0.2506297 | 0.2818010 | 8.229780 |
mean | -0.2198519 | -0.2716164 | -0.3068670 | -0.2362125 | 10.551708 |
variance | 0.6964590 | 0.9939585 | 0.9494096 | 1.0417335 | 10.551708 |
skewness | 0.0372843 | 0.2530509 | 0.1839855 | 0.3311656 | 10.551708 |
kurtosis | -0.4753057 | -0.3483064 | -0.4843925 | -0.1724373 | 3.837463 |
Adult
Table 69. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bDensity | 5.6143437 | 5.3419341 | 5.8946215 | 10.55171 |
bDensitySiteAnnual2 | -0.0012832 | -0.0016188 | -0.0009110 | 10.55171 |
bEfficiencyVisitType[2] | 1.4437105 | 1.2671676 | 1.6023786 | 10.55171 |
bEfficiencyVisitTypeDensity[1] | 0.0008742 | 0.0002957 | 0.0016557 | 8.22978 |
sDensityAnnual | 0.4853793 | 0.3527698 | 0.6664810 | 10.55171 |
sDensitySite | 0.8135312 | 0.6392286 | 1.0423186 | 10.55171 |
sDensitySiteAnnual | 0.2929567 | 0.2348879 | 0.3615738 | 10.55171 |
sDispersion | -0.6759789 | -0.7385486 | -0.6178612 | 10.55171 |
sDispersionVisitType[2] | 0.4821419 | 0.3476732 | 0.6119354 | 10.55171 |
Table 70. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
3176 | 9 | 3 | 500 | 300 | 276 | 1.018 | TRUE |
Table 71. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.1939547 | 0.2204030 | 0.2059194 | 0.2361618 | 10.5517083 |
mean | -0.2186165 | -0.2749468 | -0.3101131 | -0.2394821 | 8.9667458 |
variance | 0.6764664 | 1.0002512 | 0.9516328 | 1.0476540 | 10.5517083 |
skewness | 0.0597644 | 0.2047577 | 0.1337467 | 0.2792528 | 10.5517083 |
kurtosis | -0.2699228 | -0.2932358 | -0.4262421 | -0.1243632 | 0.4262948 |
Rainbow Trout
Subadult
Table 72. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bDensity | 4.5247947 | 4.3090214 | 4.7330819 | 10.551708 |
bDensitySiteAnnual2 | 0.0030998 | -0.0000194 | 0.0108526 | 4.211858 |
bEfficiencyVisitType[2] | 1.4468067 | 1.3002071 | 1.6050459 | 10.551708 |
bEfficiencyVisitTypeDensity[1] | -0.0012638 | -0.0015645 | -0.0009376 | 10.551708 |
sDensityAnnual | 0.2799273 | 0.1660076 | 0.4302089 | 10.551708 |
sDensitySite | 0.8236282 | 0.6726549 | 1.0046244 | 10.551708 |
sDensitySiteAnnual | 0.4594670 | 0.4171896 | 0.5067461 | 10.551708 |
sDispersion | -1.0040817 | -1.0779921 | -0.9286539 | 10.551708 |
sDispersionVisitType[2] | 0.6729044 | 0.5084309 | 0.8178001 | 10.551708 |
Table 73. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
3176 | 9 | 3 | 500 | 300 | 430 | 1.009 | TRUE |
Table 74. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.1476700 | 0.1608942 | 0.1476700 | 0.1742837 | 4.266306 |
mean | -0.1883697 | -0.2412219 | -0.2761533 | -0.2055251 | 10.551708 |
variance | 0.6336320 | 1.0271523 | 0.9801174 | 1.0729555 | 10.551708 |
skewness | -0.1112058 | 0.1219910 | 0.0486218 | 0.1960913 | 10.551708 |
kurtosis | -0.1253851 | -0.2649071 | -0.3923112 | -0.1047962 | 3.681344 |
Adult
Table 75. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bDensity | 5.0857026 | 4.8899721 | 5.2665983 | 10.551708 |
bDensitySiteAnnual2 | -0.0014601 | -0.0024873 | -0.0002079 | 5.125444 |
bEfficiencyVisitType[2] | 1.2790530 | 1.1343707 | 1.4254093 | 10.551708 |
bEfficiencyVisitTypeDensity[1] | -0.0005252 | -0.0009242 | 0.0005826 | 1.800164 |
sDensityAnnual | 0.4065795 | 0.2962779 | 0.5934062 | 10.551708 |
sDensitySite | 0.7381740 | 0.5693840 | 0.9367766 | 10.551708 |
sDensitySiteAnnual | 0.2739269 | 0.2246509 | 0.3183488 | 10.551708 |
sDispersion | -1.0167195 | -1.1001826 | -0.9426470 | 10.551708 |
sDispersionVisitType[2] | 0.5323403 | 0.3785799 | 0.6831950 | 10.551708 |
Table 76. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
3176 | 9 | 3 | 500 | 300 | 821 | 1.014 | TRUE |
Table 77. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.1120907 | 0.1319270 | 0.1199622 | 0.1448363 | 10.551708 |
mean | -0.1728934 | -0.2351263 | -0.2690604 | -0.1992549 | 8.966746 |
variance | 0.6351706 | 1.0359526 | 0.9884881 | 1.0855832 | 10.551708 |
skewness | -0.1411944 | 0.0816807 | 0.0082146 | 0.1575561 | 10.551708 |
kurtosis | -0.0135759 | -0.2523869 | -0.3709942 | -0.0993513 | 7.744353 |
Walleye
Table 78. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bDensity | 4.7583827 | 4.5379649 | 4.9874019 | 10.5517083 |
bDensitySiteAnnual2 | -0.0030645 | -0.0042116 | -0.0010457 | 7.3817833 |
bEfficiencyVisitType[2] | 0.9588480 | 0.8134857 | 1.0892770 | 10.5517083 |
bEfficiencyVisitTypeDensity[1] | 0.0004414 | -0.0008670 | 0.0031452 | 0.7524266 |
sDensityAnnual | 0.6150421 | 0.4390139 | 0.9191938 | 10.5517083 |
sDensitySite | 0.3259205 | 0.2201073 | 0.4573650 | 10.5517083 |
sDensitySiteAnnual | 0.2649366 | 0.1844590 | 0.3463508 | 10.5517083 |
sDispersion | -0.8566934 | -0.9304274 | -0.7888412 | 10.5517083 |
sDispersionVisitType[2] | 0.5134419 | 0.3574094 | 0.6724905 | 10.5517083 |
Table 79. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
3176 | 9 | 3 | 500 | 300 | 802 | 1.008 | TRUE |
Table 80. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.1278338 | 0.1634131 | 0.1492443 | 0.1782116 | 10.551708 |
mean | -0.1873457 | -0.2544441 | -0.2923371 | -0.2197764 | 10.551708 |
variance | 0.6884585 | 1.0410894 | 0.9960040 | 1.0871595 | 10.551708 |
skewness | -0.2048957 | 0.1098760 | 0.0438272 | 0.1841277 | 10.551708 |
kurtosis | -0.2841428 | -0.3482950 | -0.4716007 | -0.2035399 | 1.394361 |
Fecundity
Table 81. Parameter descriptions.
Parameter | Description |
---|---|
Fecundity[i] |
Fecundity of i th fish (eggs) |
Weight[i] |
Weight of i th fish (g) |
bFecundityWeight |
Effect of log(Weight) on log(bFecundity) |
bFecundity |
Intercept of eFecundity |
eFecundity[i] |
Expected Fecundity of i th fish |
sFecundity |
SD of residual variation in log(Fecundity) |
Mountain Whitefish
Table 82. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bFecundity | 2.9161899 | 2.1241977 | 3.7162983 | 10.55171 |
bFecundityWeight | 0.9976925 | 0.8754308 | 1.1191333 | 10.55171 |
sFecundity | 0.1310897 | 0.1015794 | 0.1813106 | 10.55171 |
Table 83. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
28 | 3 | 3 | 500 | 500 | 768 | 1 | TRUE |
Table 84. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 0.0059935 | -0.0114609 | -0.3694242 | 0.3722424 | 0.1118774 |
variance | 0.9064797 | 0.9749290 | 0.5354749 | 1.5850613 | 0.2860932 |
skewness | 0.0149416 | 0.0000306 | -0.8470844 | 0.7914794 | 0.0548545 |
kurtosis | -0.7134985 | -0.3808919 | -1.1375460 | 1.5357451 | 0.9761690 |
Table 85. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1 | 1.001 | 1.001 |
Stock-Recruitment
Table 86. Parameter descriptions.
Parameter | Description |
---|---|
EggLoss |
Proportional egg loss |
Eggs |
Total egg deposition |
Recruits |
Number of Age-1 recruits |
bAlpha |
eRecruits per Stock at low Stock density |
bBeta |
Expected density-dependence |
bEggLoss |
Effect of EggLoss on log(eRecruits) |
eRecruits |
Expected Recruits |
sRecruits |
SD of residual variation in log(Recruits) |
Mountain Whitefish
Table 87. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bAlpha | 0.0037057 | 0.0009752 | 0.0082626 | 10.5517083 |
bBeta | 0.0000002 | 0.0000000 | 0.0000005 | 10.5517083 |
bEggLoss | -0.1500900 | -2.2575553 | 2.1957646 | 0.1669245 |
sRecruits | 0.5871984 | 0.4319101 | 0.8699800 | 10.5517083 |
Table 88. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
20 | 4 | 3 | 500 | 50 | 993 | 1.002 | TRUE |
Table 89. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 12.8804931 | 0.0077018 | -0.4459022 | 0.4329071 | 10.5517083 |
variance | 0.8871422 | 0.9581590 | 0.4607771 | 1.7371333 | 0.3049677 |
skewness | -0.1555486 | 0.0146468 | -0.8950604 | 1.0137125 | 0.4735575 |
kurtosis | -1.2463233 | -0.4169529 | -1.2736863 | 1.8506637 | 3.9818527 |
Table 90. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.002 | 1.002 | 1.598 |
Rainbow Trout
Table 91. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bAlpha | 0.0039458 | 0.0012818 | 0.0083450 | 10.551708 |
bBeta | 0.0000002 | 0.0000000 | 0.0000006 | 10.551708 |
bEggLoss | 39.8063425 | -9.1529902 | 86.3906578 | 3.391837 |
sRecruits | 0.4280420 | 0.3231793 | 0.6096573 | 10.551708 |
Table 92. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
21 | 4 | 3 | 500 | 50 | 806 | 1.001 | TRUE |
Table 93. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 17.6244702 | -0.0133078 | -0.4319130 | 0.4139092 | 10.5517083 |
variance | 0.9490031 | 0.9748977 | 0.4760945 | 1.7215223 | 0.1118774 |
skewness | 0.1806145 | -0.0060781 | -0.9725603 | 0.9173140 | 0.6048020 |
kurtosis | 0.5039790 | -0.4041432 | -1.2344735 | 1.7850030 | 1.9856542 |
Table 94. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.001 | 1.003 | 1.626 |
Age-Ratios
Table 95. Parameter descriptions.
Parameter | Description |
---|---|
Age1[i] |
The number of Age-1 fish in the i th year |
Age1and2[i] |
The number of Age-1 and Age-2 fish in the i th year |
LossLogRatio[i] |
The log of the ratio of the percent egg losses |
bProbAge1Loss |
Effect of LossLogRatio on bProbAge1 |
bProbAge1 |
Intercept for logit(eProbAge1) |
eProbAge1[i] |
The expected proportion of Age-1 fish in the i th
year |
sDispersion |
SD of extra-binomial variation |
Table 96. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
bProbAge1 | 0.2631247 | -0.0638540 | 0.5845396 | 3.2207914 |
bProbAge1Loss | -0.1231114 | -0.5857534 | 0.3175392 | 0.8426244 |
sProbAge1 | 0.7625138 | 0.5714295 | 1.0656212 | 10.5517083 |
Table 97. Model summary.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
22 | 3 | 3 | 500 | 1 | 609 | 1.001 | TRUE |
Table 98. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | 0.0089939 | 0.0016096 | -0.4331818 | 0.4377352 | 0.0449048 |
variance | 0.9233599 | 0.9681931 | 0.4995536 | 1.6388864 | 0.2107455 |
skewness | -0.5146722 | 0.0060581 | -0.8760666 | 0.9776663 | 2.0800330 |
kurtosis | -0.9497531 | -0.4512111 | -1.2150035 | 1.6382316 | 1.8687137 |
Table 99. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.001 | 1 | 1.002 |
Adjusted Recruitment
Table 100. Parameter descriptions.
Parameter | Description |
---|---|
Eggloss[i] |
Proportional RB egg loss for the i th spawn year |
Mw[i] |
Abundance of age-1 MW caught in the same year as age-1 RB
from the i th spawn year |
Rb[i] |
Abundance of age-1 RB for the i th spawn year |
b0 |
Intercept for eRb[i] |
bEggLoss |
Effect of EggLoss on eRb[i] |
bMw |
Effect of Mw on eRb[i] |
eRb[i] |
Expected value of Rb[i] |
sRb |
SD of residual variation in eRb[i] |
Table 101. Model coefficients.
term | estimate | lower | upper | svalue |
---|---|---|---|---|
b0 | 9.8695782 | 9.7273434 | 10.0179453 | 10.551708 |
bEggLoss | 0.0896279 | -0.0778609 | 0.2695086 | 1.754047 |
bMw | 0.2910339 | 0.1242546 | 0.4577598 | 8.966746 |
sRb | 0.3301308 | 0.2414721 | 0.4784315 | 10.551708 |
Table 102. Model convergence.
n | K | nchains | niters | nthin | ess | rhat | converged |
---|---|---|---|---|---|---|---|
22 | 4 | 3 | 500 | 50 | 1332 | 1.001 | TRUE |
Table 103. Model posterior predictive checks.
moment | observed | median | lower | upper | svalue |
---|---|---|---|---|---|
zeros | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 | 0.0000000 |
mean | -0.0119982 | 0.0002479 | -0.3887636 | 0.3970610 | 0.0790174 |
variance | 0.8226930 | 0.9584356 | 0.4825587 | 1.7048865 | 0.7172372 |
skewness | 0.5781854 | -0.0130514 | -0.9504658 | 0.8475869 | 2.4695592 |
kurtosis | 1.5775049 | -0.3813769 | -1.1960595 | 1.4815960 | 4.4856191 |
Table 104. Model sensitivity.
all | analysis | sensitivity | bound |
---|---|---|---|
all | 1.001 | 1 | 1.001 |
Figures
Condition
Subadult
Mountain Whitefish
Rainbow Trout
Adult
Mountain Whitefish
Rainbow Trout
Walleye
Growth
Mountain Whitefish
Rainbow Trout
Walleye
Movement
Length-At-Age
Mountain Whitefish
Rainbow Trout
Survival
Adult
Mountain Whitefish
Rainbow Trout
Walleye
Observer Length Correction
Capture Efficiency
Mountain Whitefish
Subadult
Adult
Rainbow Trout
Subadult
Adult
Walleye
Abundance
Mountain Whitefish
Subadult
Adult
Rainbow Trout
Subadult
Adult
Walleye
Survival (Abundance-based)
Mountain Whitefish
Rainbow Trout
Weight
Mountain Whitefish
Rainbow Trout
Fecundity
Mountain Whitefish
Rainbow Trout
Egg Deposition
Mountain Whitefish
Rainbow Trout
Stock-Recruitment
Mountain Whitefish
Rainbow Trout
Age-Ratios
Adjusted Recruitment
Recommendations
- Develop fecundity vs weight relationship for Mountain Whitefish and Rainbow Trout on the Lower Columbia River.
Acknowledgements
The organisations and individuals whose contributions have made this analysis report possible include:
- BC Hydro
- Matt Casselman
- Guy Martel
- Teri Neighbour
- Margo Sadler
- Gillian Kong
- Okanagan Nation Alliance
- Evan Smith
- Golder Associates
- David Roscoe
- Dustin Ford
- Sima Usvyatsov
- Dana Schmidt
- Demitria Burgoon
- Chris King