Computing The Feasible Spaces Of Optimal Power Flow Problems - GitHub Pages

Transcription

1Computing the Feasible Spaces ofOptimal Power Flow ProblemsDaniel K. Molzahn, Member, IEEEAbstract—The solution to an optimal power flow (OPF) problem provides a minimum cost operating point for an electricpower system. The performance of OPF solution techniquesstrongly depends on the problem’s feasible space. This paperpresents an algorithm for provably computing the entire feasiblespaces of small OPF problems to within a specified discretizationtolerance. Specifically, the feasible space is computed by discretizing certain of the OPF problem’s inequality constraints to obtaina set of power flow equations. All solutions to the power flowequations at each discretization point are obtained using the Numerical Polynomial Homotopy Continuation (NPHC) algorithm.To improve computational tractability, “bound tightening” and“grid pruning” algorithms use convex relaxations to eliminatethe consideration of discretization points for which the powerflow equations are provably infeasible. The proposed algorithmis used to generate the feasible spaces of two small test cases.Index Terms—Optimal power flow, Feasible space, Convexoptimization, Global solutionI. I NTRODUCTIONOPTIMAL power flow (OPF) is one of the key problemsin power system optimization. The OPF problem seeksan optimal operating point in terms of a specified objectivefunction (e.g., minimizing generation cost, matching a desiredvoltage profile, etc.). Equality constraints are dictated by thenetwork physics (i.e., the power flow equations) and inequalityconstraints are determined by engineering limits on, e.g.,voltage magnitudes, line flows, and generator outputs.The OPF problem is non-convex due to the non-linearpower flow equations, may have local optima [1], and isgenerally NP-Hard [2], [3], even for networks with treetopologies [4]. Since first being formulated by Carpentierin 1962 [5], a broad range of solution approaches havebeen applied to OPF problems, including successive quadraticprograms, Lagrangian relaxation, heuristic optimization, andinterior point methods [6], [7]. Many of these approaches arecomputationally tractable for large OPF problems. However,despite often finding global solutions [8], these approachesmay fail to converge or converge to a local optimum [1], [9].Recently, there has been significant effort focused on convexrelaxations of the OPF problem. These include relaxationsbased on semidefinite programming (SDP) [2], [10]–[16],second-order cone programming (SOCP) [17]–[20], and linear programming (LP) [21], [22]. In contrast to traditionalapproaches, convex relaxations provide a lower bound on theoptimal objective value, can certify problem infeasibility, and,in many cases, provably yield the global optimum.The performance of both traditional algorithms and convexrelaxations strongly depends on the OPF problem’s feasibleArgonne National Laboratory, Energy Systems Div.: dmolzahn@anl.govspace characteristics. Accordingly, understanding OPF feasiblespaces is crucial for algorithmic research. Characterizing thefeasible spaces of OPF problems has been an important research topic [1], [3], [4], [12], [23]–[28]. This paper proposesan algorithm for computing the feasible spaces of small OPFproblems. Visualizations resulting from the computed feasible spaces increase researchers’ understanding of challengingproblems and aid in improving solution algorithms.The feasible spaces of some OPF problems can be computedanalytically. For instance, OPF problems for two-bus systemshave analytic solutions [1], [11], [29]. Exploiting problemsymmetries enables explicit expressions for the feasible spacesof other problems [24]. However, analytic solution is limitedto a small set of special cases.Related work focuses on the feasibility boundary of thepower flow equations (i.e., the set of parameters for whichsmall parameter changes results in insolvability of the powerflow equations). There have been many research efforts incomputing the distance to the power flow feasibility boundaryfor voltage collapse studies, e.g., [30]–[33]. These approachesgenerally provide small regions (often a single point) thatare on the boundary of the feasible space of the power flowequations. A more general continuation-based approach isdeveloped in [23]. Starting from a feasible point, the approachin [23] uses a continuation method to find a point on thepower flow feasibility boundary. By freeing a single parameter(e.g., active power injection at one bus), the approach in [23]uses continuation to trace curves that lie on the power flowfeasibility boundary. The approach in [23] is computationallytractable for large problems. However, it is difficult to certifythat the approach in [23] captures the entire feasible space dueto certain non-convexities such as disconnected components.Further, the approach in [23] does not consider all inequalityconstraints relevant to OPF problems.The algorithm proposed in this paper is guaranteed tocompute the entire OPF feasible space (to within a specifieddiscretization tolerance) for small OPF problems. Specifically,the proposed algorithm discretizes certain inequalities in anOPF problem into equality constraints that take the form ofpower flow equations. The Numerical Polynomial HomotopyContinuation (NPHC) algorithm [34]–[37] is then used tocompute all power flow solutions at each discretization point.The guarantees inherent to the NPHC algorithm ensure thecapturing of the entire OPF feasible space. The proposed algorithm is similar to that used in the software Paramotopy [38]for visualizing the effects of parameter variation in generalpolynomial systems.To improve computational tractability, convex relaxationsare employed to eliminate the consideration of infeasible

2discretization points. Specifically, a hierarchy of “moment”relaxations is used to tighten the right hand sides of the OPFproblem’s inequality constraints. A “grid pruning” algorithm isthen used to eliminate discretization points that are outside therelaxation’s feasible space and therefore provably infeasible.Many industrially relevant OPF problems have thousands totens-of-thousands of buses. The proposed feasible space computation algorithm is limited to much smaller problems dueto the intractability of NPHC for large problems. Fortunately,there are many small OPF problems with interesting feasiblespaces. Further, experience with the moment relaxations ofOPF problems suggests that many challenges inherent to largeproblems are related to non-convexities associated with smallregions of the large problems [13]. By enabling detailedstudies of small problems, the proposed algorithm providesthe basis for future work in characterizing the physical featuresthat give rise to challenging OPF problems.The main contributions of this paper are twofold: 1) Proposal of an OPF-specific algorithm that is guaranteed tocompute the complete feasible spaces of small problems. Thisalgorithm is particularly relevant for studies of OPF problemsthat challenge both traditional solvers and convex relaxationapproaches. 2) The use of convex relaxations to eliminateprovably infeasible points, thereby significantly improvingcomputational tractability.This paper is organized as follows. Section II describes theOPF problem. Section III presents the proposed discretizationapproach and the NPHC algorithm used to solve the powerflow equations at each discretization point. Section IV discusses the application of a hierarchy of convex relaxations toeliminate provably infeasible grid points. Section V appliesthese techniques to two OPF problems: the five- and nine-bussystems in [1]. Section VI concludes the paper.II. OVERVIEW OFTHEOPF P ROBLEM Vi fV i (Vd , Vq ) : Vdi2 Vqi2 .(1)The power flow equations describe the network physics:PGi fP i (Vd , Vq ) : PDi Vdi VqinXn k 1X(Gik Vdk Bik Vqk )(Bik Vdk Gik Vqk ) , (2a)k 1 VqinXn k 1Xk 1( Bik Vdk Gik Vqk )(Gik Vdk Bik Vqk ) . (2b)Define a quadratic cost of active power generation:2fCi (Vd , Vq ) : c2i (fP i (Vd , Vq )) c1i fP i (Vd , Vq ) c0i .(3)Each line (l, m) L is modeled by a Π circuit withmutual admittance ylm glm jblm (or, equivalently, a seriesimpedance of Rlm jXlm ) and total shunt susceptance bsh,lm .More flexible line models which include off-nominal voltageratios and non-zero phase shifts can easily be incorporated intothe proposed algorithm [39]. Define expressions for the active,reactive, and apparent power flows on the line (l, m) L: fP lm (Vd , Vq ) : glm Vdl2 Vql2 glm (Vdl Vdm Vql Vqm ) blm (Vdl Vqm Vql Vdm ) ,(4a) bsh,lmVdl2 Vql2fQlm (Vd , Vq ) : blm 2 blm (Vdl Vdm Vql Vqm ) glm (Vdl Vqm Vql Vdm ) , (4b)22fSlm (Vd , Vq ) : (fP lm (Vd , Vq )) (fQlm (Vd , Vq )) . (4c)The OPF problem isXminfCi (Vd , Vq )Vd ,Vqsubject to(5a)i GminmaxPGi fP i (Vd , Vq ) PGimaxQminGi fQi (Vd , Vq ) QGi(Vimin )2 fV i (Vd , Vq ) (Vimax )2max 2)fSlm (Vd , Vq ) (Slmmax 2fSml (Vd , Vq ) (Slm )Vqi 0This section presents an OPF formulation in terms ofcomplex voltages, active and reactive power injections, andapparent power line flow limits. Consider an n-bus powersystem, where N {1, . . . , n} is the set of all buses, Gis the set of generator buses, S is the index of the bus thatfixes the angle reference, and L is the set of all lines. LetPDi jQDi represent the active and reactive load demand atbus i N , where j 1. Let Vi Vdi jVqi represent thecomplex voltage phasor at bus i N . Superscripts “max” and“min” denote specified upper and lower limits. Buses withoutgenerators have maximum and minimum generation set tozero. Let Y G jB denote the network admittance matrix.The generator at bus i G has a quadratic cost function foractive power generation with coefficients c2i , c1i , and c0i .Define a function for squared voltage magnitude:2QGi fQi (Vd , Vq ) : QDi Vdi i N (5b) i N(5c) i N (5d) (l, m) L (5e) (l, m) L (5f)i S (5g)Constraint (5g) sets the reference bus angle to zero.III. C OMPUTATIONOFOPF F EASIBLE S PACESVisualizing OPF feasible spaces helps researchers improvesolution algorithms. To enable such visualizations, this sectionproposes an algorithm for provably computing the entire feasible space to within a specified discretization tolerance. Theproposed algorithm discretizes certain inequality constraints toform systems of polynomial equalities, which are solved usingthe NPHC algorithm [34]–[37].A. Discretization of Inequality ConstraintsThis paper discretizes certain of the OPF problem’s inequality constraints to construct equality constraints in the form ofpower flow equations. For a set of power flow equations, loadbuses (i N \ G) have specified active and reactive powerinjections PDi jQDi . A single generator bus, denoted byi S, is selected as the slack bus with a specified voltagephasor Vdi Vi , Vqi 0. The active power generation2PGi and squared voltage magnitudes Vi are specified at theremaining generator buses (i G \ S). The squared voltage

3magnitudes at generator buses Vi , i G, and active powerinjections at non-slack generator buses PGi , i G \ S, aredetermined using the following discretization.Specify discretization parameters P and V for the activepower injections and voltage magnitudes, respectively. Thechosen discretization yields the set of power flow equationsfP i (Vd , Vq ) Pimin ηi PViminfV i (Vd , Vq ) fP i (Vd , Vq ) 0 µi VfQi (Vd , Vq ) 0Vdi Vimin µi VVqi 0for each combinationµi {0, . . . , µmax},i 2i G\S(6a)i G\Si N \G(6b)(6c)i S(6e)i N \G(6d)i S(6f)of ηi {0, . . . , ηimax },i G, where ηimax : V max V mini G \ S, andP max P min⌊ i P i ⌋,µmax: ⌊ i V i ⌋, and ⌊·⌋ is the “integer floor” funcition. The number of discretization points depends on thenumber of generator buses G ; the range of the inequalityconstraints Pimax Pimin , i G \ S, and Vimax Vimin ,i G; and the chosen discretization parameters P and V .1The discretization (6) ensues the satisfaction of the OPFproblem’s constraints on active power generation (other than atthe slack bus) and generator voltage magnitudes as well as theload demands. Solutions to (6) that satisfy the other inequalityconstraints in (5) are in the feasible space of the OPF problem.Thus, a “filtering” step is required after computing the powerflow solutions at each discretization point to select the pointsthat satisfy all the inequality constraints in (5).B. Numerical Polynomial Homotopy Continuation AlgorithmEnsuring the computation of the complete feasible space requires a robust algorithm for solving the power flow equationsfrom (6). The Numerical Polynomial Homotopy Continuation(NPHC) algorithm [34]–[37] is used for this purpose.The NPHC algorithm yields all complex solutions to systems of polynomial equations. This algorithm uses continuation to trace all the complex solutions for a “start” systemof polynomial equations to a “target” system along a onedimensional parameterization. The start system is designedsuch that 1) the number of complex solutions to the startsystem upper bounds the number of complex solutions to thetarget system, and 2) all solutions to the start system can betrivially computed. The NPHC algorithm guarantees that eachsolution to the target system is connected via a continuationtrace to at least one solution of the start system [36].Consider a target system of m quadratic equations fi (x) 0, i 1, . . . , m, and variables x Cm .2 One method forconstructing the start system g (x) 0 uses the Bézoutbound [36] on the number of isolated complex solutions tof (x) 0. The Bézout bound of 2m suggests a start systemgi (x) : ai x2i bii 1, . . . , m(7)1 To reduce the number of discretization points, the slack bus S is chosenas the generator bus i G with the largest value of Pimax Pimin .2 While NPHC is applicable to higher-order polynomials, this sectionfocuses on quadratics to match the form of the power flow equations (6).where ai , bi 6 0 are generic complex numbers. Thep startsystem g (x) 0 has 2m solutions of the form xi bi /ai .Using a predictor-corrector method, the NPHC algorithmtracks all complex solutions to(1 t) f (x) κ t g (x) 0(8)from t 1 (i.e., the start system) to t 0 (i.e., the targetsystem). The constant κ is a randomly chosen complex numberwhich ensures, with probability one, that the traces do notbifurcate, turn back, or cross [36].3 Thus, NPHC is guaranteedto find all complex solutions to the target polynomial system.With each bus having two constraints and two variables, Vdiand Vqi , the power flow equations (6) for a given discretizationpoint are a square system of polynomial equalities which canbe solved with the NPHC algorithm. Only solutions with realvalued Vd and Vq are physically meaningful; solutions withany non-real Vd or Vq variables are discarded.The computational burden required for each solution ofthe NPHC algorithm depends on the number of continuationtraces. When solving multiple problems that differ only in theirparameter values, one approach for reducing the number ofcontinuation traces is to compute a parameterized homotopy.This approach solves an initial problem with generic complexparameter values (i.e., the right hand sides of (6a), (6b), and(6e)). Each set of desired parameters are then solved usingstart systems based on the solutions to the generic set ofparameters rather than (7). Since the generic-parameter systemcan have significantly fewer solutions than the Bézout bound,fewer continuation traces are required. This effectively “hotstarts” the NPHC algorithm for each set of parameters.Despite the ability to speed computation for subsequent setsof parameters, the initial solution of the generic-parametersystem with the Bézout bound can be challenging, with arequirement for 22n 2 continuation traces. With the Bézoutbound, NPHC is capable of solving systems with up tothe 14 buses [35]. Future work includes leveraging recentlydeveloped tighter bounds on the number of complex solutionsto the power flow equations [40], [41] to speed the initialcomputation required for the generic-parameter system.IV. E LIMINATING I NFEASIBLE P OINTSSome of the power flow equations resulting from the discretization in (6) may be infeasible: there may not exist anyreal solutions or all of the real solutions may fail to satisfy theinequality constraints of (5). This section proposes two screening algorithms, “bound tightening” and “grid pruning”, thatuse Lasserre’s hierarchy of convex “moment” relaxations [11],[16], [42], [43] to eliminate many infeasible points. As will bedescribed later in this section, the bound tightening algorithmimproves upon the bounds on power injections, line flows, andvoltage magnitudes given in the OPF problem description (5).The grid pruning algorithm then eliminates infeasible pointswithin the tightened constraints.3 While some traces may diverge, each solution to the target system willbe reached by at least one trace beginning at a solution to the start system.

4A. Moment Relaxation HierarchyThe order-γ moment relaxation isThe bound tightening and grid pruning algorithms employconvex relaxations to identify provably infeasible discretization points. This section describes Lasserre’s moment relaxation hierarchy [42] as applied to the OPF problem [11], [14],[16], with the recognition that any convex relaxation (e.g., [2],[10], [11], [13]–[22]) could be used for the bound tighteningand grid pruning applications to follow.Development of the moment relaxations begins with severaldefinitions. Define the vector of decision variables x̂ R2n : x̂ : Vd1 Vd2 . . . Vdn Vq1 Vq2 . . . Vqn . (9)Ly {h}subject to Mγ 1 fP i Pimin y 0 Mγ 1 Pimax fP i y 0 y 0Mγ 1 fQi Qmini max Mγ 1 Qi fQi y 0n 2 oy 0Mγ 1 fV i Vimin on 2Mγ 1 (Vimax ) fV i y 0 on max 2) fSlm y 0Mγ 2 (Slm on max 2) fSml y 0Mγ 2 (SmlA monomial is defined using an exponent vector α α1 α2α2nN2n : x̂α : Vd1Vd2 · · · Vqn. A polynomial g (x̂) : Pαgx̂,wheregisthescalarcoefficient correspond2nααα Ning to the monomial x̂α .Define a linear functional Ly (g) which replaces the monomials x̂α in a polynomial g (x̂) with scalar variables yα :Xg α yα .(10)Ly {g} : α N2nFor a matrix g (x̂), Ly {g} is appliedcomponentwise. Consider, e.g., the vector x̂ Vd1 Vd2 Vq1 Vq2 for 2a two-bus system and the polynomial g (x̂) V2min 22. (The constraint g (x̂) 0 forces the voltage Vq2Vd2minmagnitude at bus 2 to be greaterper than or equal to V2min 2unit.) Then Ly {g} V2y0200 y0002 . Thus, Ly {g}converts a polynomial g (x̂) to a linear function of y.For the order-γ relaxation, define a vector xγ consisting ofall monomials of the voltages up to order γ (i.e., x̂α such that α γ, where · is the one-norm): 2Vd1 Vd2 . . .xγ 1 Vd1 . . . Vqn Vd1 232γ. . . Vqn Vd1 Vd1 Vd2 . . . Vqn(11)The relaxations are composed of positive-semidefiniteconstrained moment and localizing matrices. The symmetricmoment matrix Mγ has entries yα corresponding to all monomials x̂α such that α 2γ: (12)Mγ {y} : Ly xγ x γ .Symmetric localizing matrices are defined for each constraint of (5). For a polynomial constraint g (x̂) 0 withlargest degree α among all monomials equal to 2η, thelocalizing matrix is: Mγ η {gy} : Ly g xγ η x γ η .(13)See [11], [39] for example moment and localizing matrices forthe second-order relaxation applied to small OPF problems.The objective functions used for the bound tightening andgrid pruning algorithms in Sections IV-B and IV-C are either1) linear functions of the active and reactive power generation,squared voltage magnitudes, and apparent power line flowsor 2) convex quadratic functions of the active powers andsquared voltage magnitudes. This section considers a generalpolynomial objective function h (Vd , Vq ) which represents ageneric function in either of these forms.min(14a)yMγ {y} 0y . ρ . 0 i N(14b) i N(14d) i N(14e) i N(14f) i N(14g) i N(14c) (l, m) L (14h) (l, m) L(14i)(14j)ρ 1, . . . , 2γ (14k)y0.0 1(14l)where ρ in the angle reference constraint (14k) is the index n k, where k S is the index of the reference bus. Alternatively,the angle reference (5g) can be used to eliminate all termscorresponding to Vqk , k S, to reduce the problem size.Constraint (14l) corresponds to the fact that x0 1.For general polynomial optimization problems, the relaxation order γ must be greater than or equal to half the largestdegree of any polynomial. Objectives that are quadratic inpower generation and/or squared voltage magnitudes as wellas functions for apparent power line flows give rise to quarticpolynomials in the voltage components, which suggests that arelaxation order γ 2 is required for problems that includethese functions. However, second-order cone programming(SOCP) reformulations for these functions enable the solutionof (14) with γ 1 [2], [39]. Note that the first-order relaxationis equivalent to the SDP relaxation of [2].Formally, for γ 1, the apparent power line flow limits (5e)and (5f) take the form of the SOCP constraints#"#"Ly {fP ml }Ly {fP lm }maxmax, Slm Slm Ly {fQml }Ly {fQlm }22 (l, m) L(15)where · 2 is the two-norm. Formulation of the quarticobjective function for the grid pruning algorithm is addressedin Section IV-C.The relaxation (14) yields a single global solution if rank Mγ {y} 1.(16)The global solution V is calculated using an eigendecomposition of the diagonal block of the moment matrix correspondingto the second-order monomials (i.e., α 2). Let σ be a unitlength eigenvectorcorresponding to the non-zero eigenvalue λ of Mγ {y} (2:2n 1,2:2n 1) . Then the globally optimal volt ages are V λσ. Relaxations in the moment hierarchy areguaranteed to yield the global optima of generic polynomialoptimization problems at a finite relaxation order [44].If the rank condition (16) is satisfied, the relaxation’sobjective value is equal to the non-convex problem’s globally

5optimal objective value. If the rank condition (16) is notsatisfied for some relaxation order (i.e., rank Mγ {y} 1),the objective value of the relaxation provides a (potentiallystrict) lower bound on the optimal objective value for the corresponding non-convex problem. The lower bound is used inthe bound tightening and grid pruning algorithms to eliminateprovably infeasible points in the discretization (6).B. Bound TighteningThe bounds on the voltage magnitudes at generator busesand on the active power outputs at non-slack generator busesdetermine the number of discretization points in (6). Thebounds on these quantities specified in the OPF problem maybe larger than the values that are actually achievable due tothe limitations imposed by other constraints. In other words,certain bounds may never be binding. It may therefore bepossible to reduce the number of discretization points bydetermining tighter bounds on the generators’ active poweroutputs and voltage magnitudes. This can be accomplishedusing a “bound tightening” algorithm similar to those proposedin [19], [45], [46] for the purpose of determining better lowerbounds on the global solutions of OPF problems.Moment relaxations are used to tighten the OPF problem’s bounds on the generators’ active and reactive poweroutputs (5b), (5c), apparent power line flows (5e), (5f), andsquared voltage magnitudes (5d). Define hc,γ {f } as thesolution to the following optimization problem:hc,γ {f } : maxyLy {cf }subject to (14b)–(14l) with relaxation order γ(17)where the parameter c { 1, 1} effectively determineswhether the objective is to minimize or maximize, f is thefunction corresponding to one of the OPF problem’s constraints (5b)–(5f), and γ is the specified relaxation order.Algorithm 1 describes the bound tightening approach. Giventhe tightest known bounds, each iteration uses (17) to compute new bounds on the maximum and minimum achievablevalues of the expressions for the constrained quantities inthe OPF problem (5). Within an iteration, the bounds foreach quantity are computed in parallel. Increasing relaxationorders of the moment hierarchy are used to determine tighterbounds. A solution to the relaxation which satisfies the rankcondition (16) yields a feasible point for the OPF problem (5).No further tightening of that constraint is possible and theconstraint is removed from the list of considered constraints.The algorithm terminates upon reaching a fixed point whereno bound tightening occurs at some iteration.There is a subtly regarding the tightening of apparent powerline flow limits. The Schur complement formulation for the theapparent power line flow limits (15) cannot be maximized inan objective function. Thus, the first-order moment relaxationcannot be directly applied to tighten these limits. However,the first-order relaxation can still applied through the use ofan upper bound on the apparent power line flows. Specifically,the squared line flow limits are bounded by the maximumvalue of the squared magnitude of the current flow multipliedby the upper bound on the squared voltage magnitude at theAlgorithm 1 Bound Tightening1: Input: γ max , upper and lower bounds ζu and ζℓ , constraintfunctions f2: Set Cu to contain all upper bound constraints3: Set Cℓ to contain all lower bound constraints4: repeat5:for each constraint in Cu do (in parallel)6:for γ 1, . . . , γ max do7:if the constraint is a flow limit for line (l, m)max 2)8:if max (h1,γ {fSlm } , h1,γ {fSml }) (SlmSetpthe flow limit for line (l, m) to9:max (h1,γ {fSlm } , h1,γ {fSml })10:11:12:13:14:15:16:17:18:19:20:21:22:23:elseif h1,γ {f } ζuUpdate the bound: ζu h1,γ {f }if the rank condition (16) is satisfiedRemove constraint from Cubreakfor each constraint in Cℓ do (in parallel)for γ 1, . . . , γ max doif h-1,γ {f } ζℓUpdate the bound: ζℓ h-1,γ {f }if the rank condition (16) is satisfiedRemove constraint from Cℓbreakuntil no bounds are updated during this iterationcorresponding terminal bus. For the line (l, m) L, thesquared magnitude of the current flow is 2 22fIlm (Vd , Vq ) : b2lm glmVdm Vqm blm bsh,lm (Vdl Vdm Vql Vqm )2 b2lm blm bsh,lm b2sh,lm /4 glm 2(Vql Vqm Vdl Vdm ) 2 b2lm glm bsh,lm glm (Vdl Vqm Vdm Vql ) Vdl2 Vql2 (18)The first-order relaxation can be used to obtain upperbounds on the apparent power line nflow limits foro themax 2) fIlm andline (l, m) L by maximizing Ly (Vlonmax 2Ly (Vm ) fIml . Higher-order relaxations directly formulate the expressions Ly {fSlm } and Ly {fSml }.C. Grid PruningEven the tightest possible constraints may still admitinfeasible points in the discretization (6). The “grid pruning”algorithm described in this section often eliminates many ofthese infeasible points. This algorithm projects a specifiedpoint in the space of active powers and squared voltagemagnitudes onto the feasible space of a convex relaxation ofthe OPF problem’s constraints. A non-zero objective valueprovides the right hand side of an ellipse centered at thespecified point. No feasible points for the OPF problem existwithin this ellipse.

6Formally, consider the optimization problemφγ (P , V , β ) : X 2 X22(fP i Pi ) β fV i (Vi )min Lyy i G\Si Gsubject to (14b)–(14l) with relaxation order γ(19)where P Rn and V Rn are vectors of parametersspecifying a point in the space of active powers and voltagemagnitudes, the parameter β specifies a scalar coefficientthat weights distances in active power to distances in squaredvoltage magnitude, and γ is the relaxation order.For φ1 (P , V , β ), the objective in (19) minimizes anauxiliary variable ω with the SOCP constraints (Ly {FV i }) (20)ω (Ly {FP i })2Algorithm 2 Grid Pruning1: Input: scalar γ max , vector β, dense discretization Ddˆ P and ˆ V yielding points P̂ defined using (6) with and V̂ , sparse discretization Ds defined using (6) withˆ P and V ˆ V yielding points P and V P 2: for each β β do3:Set Ds,β Ds4:for γ 1, . . . , γ max do5:for each point in Ds,β do (in parallel) 6:Compute φγ P , V , β with (19)7:Eliminate points in D d satisfying (21) with right hand side φγ P , V , β , P : P̂ , 8:9:V : V̂ , P : P , and V : Vif the rank condition (16) is satisfiedRemove this point from Ds,β where FP i and FV i are the vectors containing fP i , i G \S, Algorithm 3 OPF Feasible Space Computationand fV i , i G, respectively.1: Input: OPF constraint bounds and functions, scalar γ max ,A solution to (19) with φγ (P , V , β ) 0 provides theˆ P and ˆV ,vector β, dense discretization parameters right hand side of an ellipse in the space of active powers and sparsediscretizationparametersPVP and voltage magnitudes V that is centered at P and V 2: Tighten bounds using Algorithm 1 with relaxations up towith the weighting between squared voltages and active powerorder γ maxgeneration described by β :3: Save any resulting solutions that satisfy (16) 2 XX4: Construct dense and sparse discretizations, Dd and Ds ,(Pi Pi )2 β (Vi )2 (Vi )2 φγ (P , V , β )ˆP, ˆ V and P , V , respectivelyusing (6) with i Gi G\S5: Prune Dd using Algorithm 2 with γ max , β, Ds , and Dd(21)6: Save any resulting solutions that satisfy (16)Points satisfying (21) are infeasible for the OPF problem (5).47: for each discretization point in Dd do (in parallel)The grid pruning method in Algorithm 2 uses (21) to8:Solve the power flow equations (6) using NPHCeliminate infeasible discretization points. Consider two dis9: Filter the power flow solutions satisfying all constraints (5)cretizations of the form (6): a “dense” discretization with10:Output: Filtered power flow solutions augmented with theˆˆparameters P and V , which is denoted by Dd with points rank-one solutions obtained from Algorithms 1 and 2P̂ and V̂ , and a “sparse” discretization with parametersˆˆ P P and V V , which is denoted

that give rise to challenging OPF problems. The main contributions of this paper are twofold: 1) Pro-posal of an OPF-specific algorithm that is guaranteed to compute the complete feasible spaces of small problems. This algorithm is particularly relevant for studies of OPF problems that challenge both traditional solvers and convex relaxation .