Hydraulics and Surge & Swab

The hydraulics and Surge & Swab (SS) model implemented in Oliasoft WellDesign is a steady state model. It calculates the pressure drop inside the pipe and in the annulus from given inputs. The model incorporates pipe eccentricity, rotation and cuttings transport. There are a wealth of published cuttings transport models, and a few are available in Oliasoft WellDesign. With the results from a torque and drag analysis available, the effect of a buckled string is also taken into account in the pressure drop calculations. Any common rheology model can be used, as well as sets of viscometer data for a given fluid at different temperatures and pressures.

Introduction

The algorithms for calculating hydraulics and SS is based upon the work found in [1] and [2]. The calculation is done by finding all geometrical points of interest. Locations where something change geometrically, ie. radius, inclination or eccentricity, is found and then a pressure drop calculation between each point is done using the fluid present in that section of the well. The calculation is done inside the drill pipe and inside the annulus. The drill bit is handled explicitly, and a common approach, as described in eg. [3] is used. This paper also discusses the coefficient of discharge used in the formula.

The temperature profile is also input to the calculation and should be simulated a priori to the hydraulics or SS.

Mud Properties

Drilling muds comes in a huge variety, thus a generalized implementation of the mud properties is used. The density is calculated as a function of the pressure and temperature at location of interest as well as the rheology parameters. The Oliasoft WellDesign application performs calculation using the Herschel-Bulkley description of the mud shear stress as a function of the shear rate:

τ(γ)=τ0+Kγn                                                      (1)\tau(\gamma) = \tau_0 + K\cdot \gamma^n\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\; (1)

Where τ0\tau_0 is the yield stress, KK is the consistency index and n is the flow behavior index. (1) also covers the special rheology cases:

  • Newtonian fluid - linear approximation of the shear stress; τ0=0\tau_0=0 and n=1n=1

  • Bingham Plastic fluid - linear approximation of shear stress, but with yield stress; n=0n=0 and τ0>0\tau_0 > 0

  • Power Law fluid - exponential behavior of the shear stress. Only shear thinning fluids are used in drilling; 0n10\leq n \leq 1

A variety of temperature profiles can be used by the calculation, from a simple linear geothermal profile, tabulated temperature data or temperature simulations of circulating fluids.

The thermal expansion coefficient and pressure compressibility coefficient is used to determine the density of the mud. It is assumed that the mud is in its linear regime with respect to its compressibility βp\beta_p , and thermal expansion αT\alpha_T , ie. they are constants with respect to pressure pp and temperature TT :

ρ(p)=ρ0βpeTpp0                                                                          (2)ρ(T)=ρ0αTepT0T                                                                      (3)\rho(p) = \rho_0 \beta_p e^{p-p_0}_T\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\; (2) \\ \rho(T) = \rho_0 \alpha_T e^{T_0-T}_p\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\; (3)

where the subscript 0 denotes the reference density, temperature and pressure.

Fluid Mechanics Flow Equation

The calculation process for the pressure drop in the well is an iterative process. All regions with fixed geometry are treated separately and in succession as the result from one step is input to the next step. No general analytic solution for the equations exist, so a numeric process has been develop to converge on the correct pressure drop. When the pressure drop throughout the pipe and annulus has been found, all other engineering values can be calculated, eg. the (ECD).

There are several empirical equations and constants involved in the calculation. The algorithms typically have a convergence criteria O(6)\sim \mathcal{O}(-6) , thus 6 or 7 valid digits are presented for all empirical constants if this is found in the literature where they appear.

Pressure Loss Calculation in Annulus

Article [2] describes how to calculate the pressure drop in an annulus given that the drill string is free to move in the well bore, thus it depends on eccentricity, rotation and buckled state. The eccentricity is determined from the Torque & Drag (T&D) soft string model. The calculation uses the Herschel-Bulkley equation for the rheology, thus it is a general description usable for any fluid. To calculate the pressure drop in the annulus along a section of length δL\delta L , where the geometry is unchanged, the below sets of equations needs to be solved simultaneously. First the fluid shear stress τ\tau at the wall is is found from the mud flow equation, Qannulus(τ)Q_{annulus}(\tau) :

Qannulus(τ)=π(rb+rp)(rbrp)22K1nτ2(ττ0)1+nn(τ+n1+nτ0)        (4) Q_{annulus}(\tau) = \frac{\pi(r_b+r_p){(r_b-r_p)}^2}{2K^{\frac{1}{n}}\tau^2}\cdot {\left(\tau - \tau_0 \right)}^{\frac{1+n}{n}}\cdot \left(\tau + \frac{n}{1+n}\tau_0 \right)\;\;\;\;(4)

whererpr_pis the pipe radius and rbr_b is the radius of the hole. Then the Reynolds number for a yield power law fluid is calculated:

R=12v2ρ(T,p)τ                                (5)R = \frac{12 v^2 \rho(T, p)}{\tau}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(5)

where the superficial velocityvvis calculated form the flow rate and the local geometry. The absolute pressure also be known at this point, which gives the correct density of the mud.

The "generalized flow index",NN, is a generalization of the "flow index"nn, also found in the power law rheology model. When the ``flow index'' is replaced with its generalized counterpart the friction factor equation is the same.NNdepends upon thennand the yield strengthτ0\tau_0of the fluid:

N=nτ32nτ                                                                                                              (6)nτ=3n1+2n(1τ0τ(1+n)nτ02τ2(1+n)                                (7) N = \frac{n_\tau}{3 - 2n_{\tau}}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(6) \\ n_{\tau} = \frac{3n}{1 + 2n}(1-\frac{\tau_0}{\tau(1 + n)} -\frac{n\tau_0^ 2}{\tau^2(1 + n)} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(7)

From the generalized flow index the transitions from laminar to transitional and transitional to turbulent flow can be calculated:

Rlammax=2100N0.331(1+1.402rprb0.977rp2rb2);  N[0.1,1];                        (8)Rturbmin=2900N0.039(Rlammax)0.307;                                                         N[0.15,0.4];      (9) R^{\max}_{lam} = 2100 \cdot N^{0.331}(1+1.402\frac{r_p}{r_b} - 0.977\frac{r_p^2}{r_b^2}) ;\; \forall N\in [0.1, 1] ;\;\;\;\;\;\;\;\;\;\;\;\;(8)\\ R^{\min}_{turb} = 2900 \cdot N^{-0.039\cdot {\left(R^{\max}_{lam}\right)}^{0.307}} ;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\ \forall N \in [0.15, 0.4] ;\;\;\;(9)

These equations both have empirical constants (see discussion in [2]), which were determined in the general flow index ranges denoted for each Reynolds limit. The formulas are not extrapolated outside their valid range, and if the NN is outside this range the standard equations (20) and (21) (also recommended by API 10A and RP13D) is used. The empirical constants for the annulus was also determined using a configuration where rprb=0.5\frac{r_p}{r_b} = 0.5 , but for any useful application this has been slightly extended to allow [0.3,0.7]\frac{}{} \in [0.3, 0.7] .

Using these limits, the flow regime can be determined, and a different set of equations apply depending on the flow type. The friction factor ff for the flow at this velocity is calculated:

Laminar Flow: flam=Kf24Rf_{lam} = K_f \cdot \frac{24}{R} (10) Turbulent Flow: 1fturb=Kf4N0.75log10(Rfturb(1N2))0.4N1.2\frac{1}{\sqrt{f{turb}}} = K_f \cdot \frac{4}{N^{0.75}}\log{10}\left(R\cdot f_{turb}^{(1-\frac{N}{2})} \right) - \frac{0.4}{N^{1.2}} (11)

Transitional Flow is calculated as an extrapolation between the friction factor for laminar flow and turbulent flow:

ftrans=flam+RRlammaxRturbminRlammax(fturbflam)                                                              (12)f_{trans} = f_{lam} + \frac{R - R_{lam}^{\max}}{R_{turb}^{\min} - R_{lam}^{\max}} (f_{turb}-f_{lam})\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(12)

The empirical constant K in equation (10) and (11) is found from:

Kf={1ε=01C1εNκ0.08454C2ε2Nκ0.1852+C3ε3Nκ0.2527ε>0        (13)C1=0.072,C2=32,C3=0.96            ε>0R<Rlammax                                                      (14)C1=0.048,C2=23,C3=0.0258      ε>0R>Rturbmin                                                      (15)κ=rprb                                                                                                                                                                                                        (16) K_f = \begin{cases} 1 & \forall \varepsilon = 0 \\ 1 - C_1\frac{\varepsilon}{N}\kappa^{0.08454} - C_2\varepsilon^2\sqrt{N}{\kappa}^{0.1852} + C_3\varepsilon^3\sqrt{N}{\kappa}^{0.2527} & \forall \varepsilon > 0 \end{cases} \;\;\;\;(13) \\ C_1 = 0.072, C_2 = \frac{3}{2}, C_3 = 0.96\;\;\;\;\;\;\, \forall \varepsilon > 0 \wedge R < R_{lam}^{\max} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(14)\\ C_1 = 0.048, C_2 = \frac{2}{3}, C_3 = 0.0258\;\;\; \forall \varepsilon > 0 \wedge R > R_{turb}^{\min} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(15) \\ \kappa= \frac{r_p}{r_b} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(16)

Finally the pressure loss for the section can be calculated from the friction factor, ff:

dpdl=Cpfρ(T,p)v2rbrp                                              (17)\frac{dp}{dl} = C_p \cdot \frac{f\rho(T, p)v^2}{r_b-r_p}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(17)

Cp=1C_p=1 if the drill string sf not buckled. This applies to any type of buckling (sinusoidal, partial helical or fully helical, see [4]). If the string is buckled the empirical correction for the pressure loss is calculated as:

Cp={1                                                                                                                                      FFS<10.2287N0.0580FFS+0.014844ω+0.4289      FFS1R<Rlammax        (18)1.0267N0.0096FFS+0.00468ω+1.4222    FFS1R[Rlammax,Rturbmin]1.7821N0.0132FFS+0.016656ω+2.7983  FFS1R>Rturbmin C_p = \begin{cases} 1 \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\; \forall \frac{F}{F_S} < 1 \\ 0.2287N - 0.0580\frac{F}{F_S} + 0.014844\omega + 0.4289\;\;\; \forall \frac{F}{F_S} \geq 1 \wedge R < R^{\max}_{lam} \;\;\;\;(18)\\ -1.0267N - 0.0096\frac{F}{F_S} + 0.00468\omega + 1.4222 \;\; \forall \frac{F}{F_S} \geq 1 \wedge R \in [R^{\max}_{lam}, R_{turb}^{\min}] \\ -1.7821N - 0.0132\frac{F}{F_S} + 0.016656\omega + 2.7983 \; \forall \frac{F}{F_S} \geq 1 \wedge R > R_{turb}^{\min} \end{cases}

where FF is the tension in the drill string, FSF_S is the sinusoidal buckling limit, and ω\omega is the rotation frequency.

Pressure Loss Calculation in Pipe

Flow in pipe (circular conduit) is calculated in a similar way. The formulas used are found in [1]. The following equation replaces the corresponding equations from the previous section. First the generalized flow index, NN is calculated as:

N=((12n)τ+3nτ0n(ττ0)+2n(1+n)((1+2n)τ2+nτ0τ)n(1+n)(1+2n)τ2+2n2(1+n)ττ0+2n3τ02)1(19)N = {\left(\frac{(1 - 2n) \tau + 3n\tau_0}{n(\tau - \tau_0)} + \frac{2n(1 + n) ((1 + 2 n) \tau^2 + n \tau_0 \tau)} {n (1 + n)(1 + 2n)\tau^2 + 2n^2 (1 + n) \tau \tau_0 + 2n^3 \tau_0^2}\right)}^{-1} (19)

The Reynolds number limits for laminar to transitional and from transitional to turbulent flow in a pipe is given by:

Rlammax=32501150N        (20)Rturbmin=41501150N        (21) R_{lam}^{\max} = 3250 - 1150N \;\;\;\;(20)\\ R_{turb}^{\min} = 4150 - 1150N\;\;\;\;(21)

With the given flow in the pipe, the fluid shear stress can be calculated from the following equation:

Qpipe(τ)=πrp3n(ττ0)1+1n(3n+1)K1nτ3(τ2+2nτ0τ1+2n+2n2τ02(1+n)(1+2n))    (22)Q_{pipe}(\tau) = \frac{\pi r_p^3 n {(\tau - \tau_0)}^{1+\frac{1}{n}}} {(3n + 1)K^{\frac{1}{n}} \tau^3} \left( \tau^2 + \frac{2n\tau_0\tau}{1 + 2n} + \frac{2n^2\tau_0^2}{(1 + n) (1 + 2n)}\right) \;\;(22)

With the now known shear stress in the fluid, its Reynolds number is given by:

R=8v2ρ(T,p)τ                      (23) R = \frac{8 v^2 \rho(T, p)}{\tau} \;\;\;\;\;\;\;\;\;\;\;(23)

Setting ε=0\varepsilon = 0 , the flow friction factor in the pipe can be calculated from equation (10), (11) or (12), using the results from equations (19) and (23). The pressure drop for the section is then calculated from equation (17) with C=1C=1 .

Initial Conditions

The minimum required inputs for doing a mud flow calculation are flow rate and pressure. These can be given by 4 different combination:

  1. Flow from pump, pressure at pump -The exit pressure of the pump and the corresponding volumetric flow rate from the pump is user input.

  2. Flow at annulus exit, pressure at exit - The exit pressure of the annulus and corresponding flow rate (default mode, where pressure is 1 atm.) If pressure is bigger than 1 atm, this mode can be used as MPD calculations.

  3. Flow from pump, pressure at annulus exit - Use this option if performing MPD calculations.

  4. Flow at annulus exit, pressure at pump - Use this option if performing MPD calculations.

Analysis using option 3 or 4, where the pressure is not known at the given flow rate location, the flowing pressure is an unknown parameter in the calculation, and will thus be calculated.

Pipe and Annulus Velocity

In all situations (except for "Fixed depth'' circulation) the pipe is moving relative to the annulus. This means that the mud velocity vmudv_{mud} has to be calculated relative to its location. Inside the pipe the mud velocity is calculated relative to the pipe, which introduces a fixed offset, vROPv_{ROP} between apparent velocity and the velocity calculated from mud volume flow and cross section at any MD.

In the annulus the pipe movement causes a non-symmetric shear stress profile in the transverse direction in the mud since the wall of the bore is static. This is not considered in the published literature, since for all scenarios except surge and swab, the mud velocity is much bigger than the pipe velocity, thus the approximation is sound. Since this is not the case in SS, Oliasoft WellDesign has introduced an approximation to the superficial velocity of the mud in the annulus. The flow velocity profile is proportional to τ2\tau^2 . Integrating this renders the following approximation to the superficial flow velocity:

vapparent=vmud+vROP3                      (24) v_{apparent} = v_{mud} + \frac{v_{ROP}}{3}\;\;\;\;\;\;\;\;\;\;\;(24)

Equivalent Circulating Density (ECD)

ρECD=ρ(T,p)+pfriction(lMD)ghTVD                      (25) \rho_{ECD} = \rho(T, p) + \frac{p_{friction}(l_{MD})}{g\cdot h_{TVD}}\;\;\;\;\;\;\;\;\;\;\;(25)

where lMDl_{MD} is the distance along the trajectory to point MD, pfriction(lMD)p_{friction}(l_{MD}) is the frictional pressure loss down to this MD, gg is the gravitational constant and hTVDh_{TVD} is the TVD between the (RKB) and this MD.

Drill Bit Calculation

The pressure drop is calculated according to the standard in the industry. The pressure drop coefficient is most probably manufacturer specific, see eg. [3] for a discussion of its value. The following values are calculated:

Phyd=ΔpQ(τ)                      (26)vnozzle=Q(τ)Anozzles                      (27)Fimpact=Q2(τ)ρAnozzles                      (28)Peff=Phydπrbit2                                      (29) P_{hyd} = \Delta p \cdot Q(\tau) \;\;\;\;\;\;\;\;\;\;\;(26)\\ v_{nozzle} = \frac{Q(\tau)}{A_{nozzles}} \;\;\;\;\;\;\;\;\;\;\;(27)\\ F_{impact} = \frac{Q^2(\tau) \rho}{A_{nozzles}} \;\;\;\;\;\;\;\;\;\;\;(28)\\ P_{eff} = \frac{P_{hyd}}{\pi r_{bit}^2}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(29)

where Δp\Delta p is the pressure drop through the nozzles of the drill bit, PhydP_{hyd} is the so--called "hydraulic horse power'', vnozzlev_{nozzle} is the average mud velocity in the nozzles, FimpactF_{impact} is the impact force of the mud as it exits the nozzles, PeffP_{eff} is the so--called "hydraulic horse power intensity'', and rbitr_{bit} is the drill bit radius.

Gel Break Pressure Calculation

The gel break pressure is calculated from the gel strength (yield stress, yield strength), τ0\tau_0 . It is calculated for each geometry section ii , where the geometry is constant. The gel breaking pressure is the sum of all these sections inside the pipe and back up through the annulus:

Pgel=i=0imax2τ0dlipiperp+i=imax02τ0dliannulusrbrp                (30) P_{gel} = \sum_{i = 0}^{i_{\max}} \frac{2\tau_0 dl_i^{pipe}}{r_p} + \sum_{i = i_{\max}}^{0} \frac{2\tau_0 dl_i^{annulus}}{r_b - r_p} \;\;\;\;\;\;\;\;(30)

where dlipipedl^{pipe}_iand dliannulusdl^{annulus}_i is the length of section ii where the geometry is constant, for pipe and annulus respectively, and MDimaxMD{i_{\max}} is the bottom of the well.

Surge & Swab

In surge and swab, it is the pipe movement that causes the mud to flow (not the pumps). In most cases it will flow in the same direction in both pipe and annulus. The algorithms will search for the initial conditions at the drill bit (drill pipe bottom), determining the pressure and the split of the flow between the pipe and the annulus. The pressure profile is then calculated from the found initial conditions, using the equations in sections 3.1 and 3.2.

Avoiding Fracture and Ingress

Oliasoft WellDesign has developed an algorithm that finds the limits, in terms of drill pipe velocity with respect to avoiding going beyond the fracture pressure (loss of circulation) and below the pore pressure (ingress of fluids) in the annulus. The" Surge to frac'' and the "Swab to pore'' analysis modes can be performed with an open or a closed drill bit (or drill pipe end). The calculation uses the above presented pressure drop calculations when doing this search.

Hole Cleaning

The transport of cuttings in the annulus is calculated using [5] and [6]. It is based upon finding the slip speed of the cuttings, and if the mud velocity is too slow to transport the cuttings, a cuttings bed will form, until the mud velocity is high enough (mud velocity increases with increasing cuttings bed cross sectional area). Below a certain inclination the cuttings bed will not be stable. In such a case the cross sectional fraction of cuttings will accumulate until the mud velocity is high enough to transport the cuttings. This will necessarily cause a high increase in the mud pressure drop in the annulus.

The cuttings volumetric flow rate, QcutQ_{cut} is given by:

Qcut(vROP)=vROPπrp2                    (31)Q_{cut}(v_{ROP}) = v_{ROP} \pi r_p^2\;\;\;\;\;\;\;\;\;\;(31)

where vROPv_{ROP} is the rate of penetration.

In [6], an empirical equation for determining the mud's ability to transport the cuttings away from the drill bit was found from lab tests, determining an otherwise unsolvable problem on how to determine the cuttings to mud volumetric fraction, cvolCutc_{volCut} :

cvolCut=2.1vROP+0.00505                    (32)c_{volCut} = 2.1 v_{ROP} + 0.00505\;\;\;\;\;\;\;\;\;\;(32)

Reference [6] gives a complete cuttings transport calculation, but too many of the empirical constants are based on too low statistics to be trusted, in addition it is only applicable for α=0\alpha = 0 and α>55\alpha > 55^{\circ} . Thus, equation (32) is the only one used in the implementation.

In [5] an additional 2 special numerical constants were constructed, which were analyzed from several earlier lab tests:

Kcorr={1+α(359.479+ρ)(10ω)404334α45                  (33)1+2(359.479+ρ)(10ω)17970.4α>45A={40RcutRcut<322RcutRcut[3,3001.54Rcut300                                                  (34) K_{corr} = \begin{cases} 1 + \frac{\alpha (359.479 + \rho) (10 - \omega)}{404334} & \forall \alpha \leq 45 \;\;\;\;\;\;\;\;\;(33)\\ 1 + 2\cdot \frac{(359.479 + \rho) (10 - \omega)}{17970.4} & \forall \alpha > 45 \end{cases} \\ A = \begin{cases} \frac{40}{R_{cut}} & \forall R_{cut} < 3\\ \frac{22}{\sqrt{R_{cut}}} & \forall R_{cut} \in [3, 300\rangle\\ % chktex 15 1.54 & \forall R_{cut} \geq 300 \end{cases} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(34)

There is a big discontinuity in AA when RcutR_{cut}passed 3. This has not been resolved, thus RcutR_{cut}has an artificial low limit of 3. When the above values are determined the following sets of equations must be solved simultaneously:

μapparent=μ+0.25063τ0(rbrp)vmin                                                                      (35)vslip=AKcorrdcut(ρcutρ)ρ                                                                              (36)Rcut=vslipdcutρμapparent                                                                                                                            (37)vcut=Qcut(vROP)ccutπ(rb2rp2)                                                                                                              (38)vmin=vcut+vslip                                                                                                                          (39)Abed=π(rb2rp2)Qannulus(τ)vmin(1cvolCut)                                                              (40)ccut=11+Qannulus(τ)+Qcut(vROP)Qannulus(τ)(1vSlipvmin)                  (41) \mu_{apparent} = \mu + \frac{0.25063 \tau_0 (r_b-r_p)}{v_{\min}} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(35)\\ v_{slip} = A \cdot K_{corr} \sqrt{\frac{d_{cut} (\rho_{cut} - \rho)}{\rho}}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(36)\\ R_{cut} = \frac{v_{slip} d_{cut} \rho}{\mu_{apparent}} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(37)\\ v_{cut} = \frac{Q_{cut}(v_{ROP})}{c_{cut} \pi(r_b^2 - r_p^2)}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(38) \\ v_{\min} = v_{cut} + v_{slip}\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(39) \\ A_{bed} = \pi (r_b^2-r_p^2) - \frac{Q_{annulus}(\tau)}{v_{\min}(1-c_{volCut})} \;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;\;(40)\\ c_{cut} = \frac{1}{1 + \dfrac{Q_{annulus}(\tau)+Q_{cut}(v_{ROP})}{Q_{annulus}(\tau)} \cdot \left(1 - \dfrac{v_{Slip}}{v_{\min}}\right)} \;\;\;\;\;\;\;\;\;(41)

where α\alpha is inclination angle, dcutd_{cut} is the cuttings average diameter, vslipv_{slip} is slip velocity, vcutv_{cut} cuttings velocity, vminv_{\min} minimum transport velocity. AbedA_{bed} is the cuttings bed cross sectional area and ccutc_{cut} is the relative cross section in the annulus occupied by the cuttings. If the mud velocity is too low, vmud<vmin(1cvolCut)v_{mud} < v_{\min}(1-c_{volCut}) , the cuttings bed area is calculated, if not Abed=0A_{bed} = 0 .

Available Calculation Modes

These hydraulic analysis modes are available:

  • Fixed Depth - Perform circulation of the mud with the drill string at a specified depth. Gives access to detailed data, throughout the trajectory. Analysis can be done with or without hole cleaning.

  • Drilling - Perform circulation of the mud while doing the drilling. The drill string is moved step wise downward, and a "Fixed depth" calculation is performed at each new depth. Summary data is compiled.

  • Variable Rate of Penetration - At a fixed depth a range of penetration rates are analyzed. A "Fixed depth" analysis is performed at each rate, from which summary data is compiled as a function of the penetration rate.

  • Variable Pump Rate - At a fixed depth a range of pump rates are analyzed. A "Fixed depth" analysis is performed at each pump rate, from which summary data is compiled as a function of pump rate.

  • Gel Break - Gel break pressure is calculated at a series of depths from top to bottom, in a series similar to "Drilling" mode. Only data related to the required breaking pressure is calculated.

These surge and swab analysis modes are available:

  • Surge at Depth - This analysis is similar to the hydraulics "Fixed depth" analysis. At a specified depth the result of pushing the drill string into the well bore (an infinitesimal short distance) is analyzed.

  • Swab at Depth - This analysis is similar to the hydraulics "Fixed depth" analysis. At a specified depth the result of pulling the drill string out of the well bore (an infinitesimal short distance) is analyzed.

  • Surge - The analysis of pushing the drill string into the wellbore from top to bottom is analyzed. The drill string is moved step wise downward and a "Surge at depth" analysis is performed at each depth. Summary data is compiled.

  • Swab - The analysis of pulling the drill string out of the well bore from bottom to top is analyzed. The drill string is moved step wise upward and a "Swab at dept" analysis is performed at each depth. Summary data is compiled.

  • Surge to Frac at Depth - A "Surge at depth'' analysis is performed, and a search for the surge velocity that renders the minimum allowed distance between the pressure profile of the mud and the fracture pressure profile of the formation, at any point in the trajectory.

  • Swab to Pore at Depth - A "Swab at depth" analysis is performed, and a search for the swab velocity that renders the minimum allowed distance between the pressure profile of the mud and the pore pressure profile of the formation, at any point in the trajectory.

  • Surge to Frac - Similar to the "Surge'', but for each step downwards a "Surge to frac at depth" calculation is performed. A velocity profile is available in the summary result.

  • Swab to Pore - Similar to the "Swab", but for each step upwards a "Swab to pore at depth" calculation is performed. A velocity profile is available in the summary result.

References

[1] Bernt Aadnoy, Iain Cooper, Stefan Miska, Robert F. Mitchell, and Michael L. Payne. Advanced Drilling and Well Technology. Society of Petroleum Engineers, 2009. ISBN: 978-1-55563-145-1.

[2] Oney Erge nd et al. The effects of drillstring eccentricity, rotation and buckling configurations on annular frictional pressure losses while circulating yield power law fluids. Society of Petroleum Engineers, 30(3), 2015. SPE-167950-PA doi:https://doi.org/10.2118/167950-PA.

[3] Leon Robinson. Drill bit pressure loss. American association of drilling engineers, 2010. AADE-10-F-HO-26.

[4] Oliasoft Truls M. Larsen. Technical specification torque and drag " soft string model". Online PDF.

[5] Rudi Rubiandini. Equation for estimating mud minimum rate for cuttings transport in an inclined-until-horizontal well. Society of Petroleum Engineers, SPE/IADC Middle East Drilling Technology Conference, 8-10 November, Abu Dhabi, United Arab Emirates, 1999. SPE-1172519-MS doi:https://doi.org/10.2118/57541-MS.

[6] T.I. Larsen, A.A. Pilehvari, and J.J. Azar. Development of a new cuttings transport model for high angle wellbores including horizontal wells. Society of petroleum engineers, 12(2), 1997. SPE-25872-PA doi: https://doi.org/10.2118/25872-PA.

Last updated